Last updated: 2022-02-11

Checks: 6 1

Knit directory: Serreze-T1D_Workflow/

This reproducible R Markdown analysis was created with workflowr (version 1.6.2). The Checks tab describes the reproducibility checks that were applied when the results were created. The Past versions tab lists the development history.


Great! Since the R Markdown file has been committed to the Git repository, you know the exact version of the code that produced these results.

Great job! The global environment was empty. Objects defined in the global environment can affect the analysis in your R Markdown file in unknown ways. For reproduciblity it’s best to always run the code in an empty environment.

The command set.seed(20220210) was run prior to running the code in the R Markdown file. Setting a seed ensures that any results that rely on randomness, e.g. subsampling or permutations, are reproducible.

Great job! Recording the operating system, R version, and package versions is critical for reproducibility.

Nice! There were no cached chunks for this analysis, so you can be confident that you successfully produced the results during this run.

Using absolute paths to the files within your workflowr project makes it difficult for you and others to run your code on a different machine. Change the absolute path(s) below to the suggested relative path(s) to make your code more reproducible.

absolute relative
/Users/corneb/Documents/MyJax/CS/Projects/Serreze/qc/workflowr/Serreze-T1D_Workflow .

Great! You are using Git for version control. Tracking code development and connecting the code version to the results is critical for reproducibility.

The results in this page were generated with repository version fc17722. See the Past versions tab to see a history of the changes made to the R Markdown and HTML files.

Note that you need to be careful to ensure that all relevant files for the analysis have been committed to Git prior to generating the results (you can use wflow_publish or wflow_git_commit). workflowr only checks the R Markdown file, but you know if there are other scripts or data files that it depends on. Below is the status of the Git repository when the results were generated:


Ignored files:
    Ignored:    .DS_Store

Untracked files:
    Untracked:  data/GM_covar.csv
    Untracked:  data/bad_markers_all_4.batches.RData
    Untracked:  data/covar_cleaned_ici.vs.eoi.csv
    Untracked:  data/covar_cleaned_ici.vs.pbs.csv
    Untracked:  data/e.RData
    Untracked:  data/e_snpg_samqc_4.batches.RData
    Untracked:  data/e_snpg_samqc_4.batches_bc.RData
    Untracked:  data/errors_ind_4.batches.RData
    Untracked:  data/errors_ind_4.batches_bc.RData
    Untracked:  data/genetic_map.csv
    Untracked:  data/genotype_errors_marker_4.batches.RData
    Untracked:  data/genotype_freq_marker_4.batches.RData
    Untracked:  data/gm_allqc_4.batches.RData
    Untracked:  data/gm_samqc_3.batches.RData
    Untracked:  data/gm_samqc_4.batches.RData
    Untracked:  data/gm_samqc_4.batches_bc.RData
    Untracked:  data/gm_serreze.192.RData
    Untracked:  data/percent_missing_id_3.batches.RData
    Untracked:  data/percent_missing_id_4.batches.RData
    Untracked:  data/percent_missing_id_4.batches_bc.RData
    Untracked:  data/percent_missing_marker_4.batches.RData
    Untracked:  data/pheno.csv
    Untracked:  data/physical_map.csv
    Untracked:  data/qc_info_bad_sample_3.batches.RData
    Untracked:  data/qc_info_bad_sample_4.batches.RData
    Untracked:  data/qc_info_bad_sample_4.batches_bc.RData
    Untracked:  data/sample_geno.csv
    Untracked:  data/sample_geno_bc.csv
    Untracked:  data/serreze_probs.rds
    Untracked:  data/serreze_probs_allqc.rds
    Untracked:  data/summary.cg_3.batches.RData
    Untracked:  data/summary.cg_4.batches.RData
    Untracked:  data/summary.cg_4.batches_bc.RData
    Untracked:  output/Percent_missing_genotype_data_4.batches.pdf
    Untracked:  output/Percent_missing_genotype_data_per_marker.pdf
    Untracked:  output/Proportion_matching_genotypes_before_removal_of_bad_samples_4.batches.pdf
    Untracked:  output/genotype_error_marker.pdf
    Untracked:  output/genotype_frequency_marker.pdf

Unstaged changes:
    Modified:   analysis/2.2.1_snp_qc_4.batches.Rmd

Note that any generated files, e.g. HTML, png, CSS, etc., are not included in this status report because it is ok for generated content to have uncommitted changes.


These are the previous versions of the repository in which changes were made to the R Markdown (analysis/4.1.1_qtl.analysis_binary_ici.vs.pbs_snpsqc.Rmd) and HTML (docs/4.1.1_qtl.analysis_binary_ici.vs.pbs_snpsqc.html) files. If you’ve configured a remote Git repository (see ?wflow_git_remote), click on the hyperlinks in the table below to view the files as they were in that past version.

File Version Author Date Message
Rmd fc17722 Belinda Cornes 2022-02-11 QTL Mapping correcting MAF cutoff
html 1218e08 Belinda Cornes 2022-02-11 Build site.
Rmd 8427b21 Belinda Cornes 2022-02-11 QTL Mapping after snp qc

Loading Data

We will load the data and subset indivials out that are in the groups of interest. We will create a binary phenotype from this (PBS ==0, ICI == 1).

load("data/gm_allqc_4.batches.RData")

#gm_allqc
gm=gm_allqc
gm
Object of class cross2 (crosstype "bc")

Total individuals               188
No. genotyped individuals       188
No. phenotyped individuals      188
No. with both geno & pheno      188

No. phenotypes                    1
No. covariates                    6
No. phenotype covariates          0

No. chromosomes                  20
Total markers                131578

No. markers by chr:
    1     2     3     4     5     6     7     8     9    10    11    12    13 
 9977 10005  7858  7589  7621  7758  7413  6472  6725  6396  7154  6137  6085 
   14    15    16    17    18    19     X 
 5981  5346  5019  5093  4607  3564  4778 
#pr <- readRDS("data/serreze_probs_allqc.rds")
#pr <- readRDS("data/serreze_probs.rds")

##extracting animals with ici and eoi group status
miceinfo <- gm$covar[gm$covar$group == "PBS" | gm$covar$group == "ICI",]
table(miceinfo$group)

ICI PBS 
 92  21 
mice.ids <- rownames(miceinfo)

gm <- gm[mice.ids]
gm
Object of class cross2 (crosstype "bc")

Total individuals               113
No. genotyped individuals       113
No. phenotyped individuals      113
No. with both geno & pheno      113

No. phenotypes                    1
No. covariates                    6
No. phenotype covariates          0

No. chromosomes                  20
Total markers                131578

No. markers by chr:
    1     2     3     4     5     6     7     8     9    10    11    12    13 
 9977 10005  7858  7589  7621  7758  7413  6472  6725  6396  7154  6137  6085 
   14    15    16    17    18    19     X 
 5981  5346  5019  5093  4607  3564  4778 
#pr.qc <- pr
#for (i in 1:20){pr.qc[[i]] = pr.qc[[i]][mice.ids,,]}

#bin_pheno <- NULL
#bin_pheno$PBS <- ifelse(gm$covar$group == "PBS", 1, 0)
#bin_pheno$ICI <- ifelse(gm$covar$group == "ICI", 1, 0)
#bin_pheno <- as.data.frame(bin_pheno)
#rownames(bin_pheno) <- rownames(gm$covar)

gm$covar$ICI.vs.PBS <- ifelse(gm$covar$group == "PBS", 0, 1)

##dropping monomorphic markers within the dataset

g <- do.call("cbind", gm$geno)

gf_mar <- t(apply(g, 2, function(a) table(factor(a, 1:2))/sum(a != 0)))
#gn_mar <- t(apply(g, 2, function(a) table(factor(a, 1:2))))

gf_mar <- gf_mar[gf_mar[,2] != "NaN",]

count <- rowSums(gf_mar <=0.05)
low_freq_df <- merge(as.data.frame(gf_mar),as.data.frame(count), by="row.names",all=T)
low_freq_df[is.na(low_freq_df)] <- ''
low_freq_df <- low_freq_df[low_freq_df$count == 1,]
rownames(low_freq_df) <- low_freq_df$Row.names

low_freq <- find_markerpos(gm, rownames(low_freq_df))
low_freq$id <- rownames(low_freq)

nrow(low_freq)
[1] 98210
low_freq_bad <- merge(low_freq,low_freq_df, by="row.names",all=T)
names(low_freq_bad)[1] <- c("marker")

gf_mar <- gf_mar[gf_mar[,2] != "NaN",]
MAF <- apply(gf_mar, 1, function(x) min(x))
MAF <- as.data.frame(MAF)
MAF$index <- 1:nrow(gf_mar)
gf_mar_maf <- merge(gf_mar,as.data.frame(MAF), by="row.names")
gf_mar_maf <- gf_mar_maf[order(gf_mar_maf$index),]

gfmar <- NULL
gfmar$gfmar_mar_0 <- sum(gf_mar_maf$MAF==0)
gfmar$gfmar_mar_1 <- sum(gf_mar_maf$MAF< 0.01)
gfmar$gfmar_mar_5 <- sum(gf_mar_maf$MAF< 0.05)
gfmar$gfmar_mar_10 <- sum(gf_mar_maf$MAF< 0.10)
gfmar$gfmar_mar_15 <- sum(gf_mar_maf$MAF< 0.15)
gfmar$gfmar_mar_25 <- sum(gf_mar_maf$MAF< 0.25)
gfmar$gfmar_mar_50 <- sum(gf_mar_maf$MAF< 0.50)
gfmar$total_snps <- nrow(as.data.frame(gf_mar_maf))

gfmar <- t(as.data.frame(gfmar))
gfmar <- as.data.frame(gfmar)
gfmar$count <- gfmar$V1

gfmar[c(2)] %>%
  kable(escape = F,align = c("ccccccccc"),linesep ="\\hline") %>%
  kable_styling(full_width = F) %>%
  kable_styling("striped", full_width = F)  %>%
  row_spec(8 ,bold=T,color= "white",background = "black")
count
gfmar_mar_0 89064
gfmar_mar_1 92616
gfmar_mar_5 98209
gfmar_mar_10 99489
gfmar_mar_15 99575
gfmar_mar_25 100325
gfmar_mar_50 131283
total_snps 131578
gm_qc <- drop_markers(gm, low_freq_bad$marker)
gm_qc <- drop_nullmarkers(gm_qc)
 
gm = gm_qc
gm
Object of class cross2 (crosstype "bc")

Total individuals              113
No. genotyped individuals      113
No. phenotyped individuals     113
No. with both geno & pheno     113

No. phenotypes                   1
No. covariates                   7
No. phenotype covariates         0

No. chromosomes                 20
Total markers                33368

No. markers by chr:
   1    2    3    4    5    6    7    8    9   10   11   12   13   14   15   16 
3009 2925 2089 2103 1982 2099 1915 1739 2050 1253 2102 1428 1656 1728 1101  977 
  17   18   19    X 
 422 1118 1084  588 
markers <- marker_names(gm)
gmapdf <- read.csv("/Users/corneb/Documents/MyJax/CS/Projects/Serreze/haplotype.reconstruction/output_hh/genetic_map.csv")
pmapdf <- read.csv("/Users/corneb/Documents/MyJax/CS/Projects/Serreze/haplotype.reconstruction/output_hh/physical_map.csv")
mapdf <- merge(gmapdf,pmapdf, by=c("marker","chr"), all=T)
rownames(mapdf) <- mapdf$marker
mapdf <- mapdf[markers,]
names(mapdf) <- c('marker','chr','gmapdf','pmapdf')
mapdf <- mapdf[!duplicated(mapdf[c(2:3)]),]

pr.qc <- calc_genoprob(gm)

Genome-wide scan

For each of the phenotype analyzed, permutations were used for each model to obtain genome-wide LOD significance threshold for p < 0.01, p < 0.05, p < 0.10, respectively, separately for X and automsomes (A).

The table shows the estimated significance thresholds from permutation test.

We also looked at the kinship to see how correlated each sample is. Kinship values between pairs of samples range between 0 (no relationship) and 1.0 (completely identical). The darker the colour the more indentical the pairs are.

Xcovar <- get_x_covar(gm)
#addcovar = model.matrix(~Sex, data = covars)[,-1]

#K <- calc_kinship(pr.qc, type = "loco")
#heatmap(K[[1]])
#K.overall <- calc_kinship(pr.qc, type = "overall")
#heatmap(K.overall)
kinship <- calc_kinship(pr.qc)
heatmap(kinship)

Version Author Date
1218e08 Belinda Cornes 2022-02-11
#operm <- scan1perm(pr.qc, gm$covar$phenos, Xcovar=Xcovar, n_perm=2000)
#operm <- scan1perm(pr.qc, gm$covar$phenos, addcovar = addcovar, n_perm=2000)
#operm <- scan1perm(pr.qc, gm$covar$phenos, n_perm=2000)
operm <- scan1perm(pr.qc, gm$covar["ICI.vs.PBS"], model="binary", n_perm=10, perm_Xsp=TRUE, chr_lengths=chr_lengths(gm$gmap))

summary_table<-data.frame(unclass(summary(operm, alpha=c(0.01,  0.05, 0.1))))
names(summary_table) <- c("autosomes","X")
summary_table$significance.level <- rownames(summary_table)

rownames(summary_table) <- NULL

summary_table[c(3,1:2)] %>%
  kable(escape = F,align = c("ccc")) %>%
  kable_styling("striped", full_width = T) %>%
  column_spec(1, bold=TRUE)
significance.level autosomes X
0.01 3.778383 3.253517
0.05 3.726880 3.163040
0.1 3.662342 3.044723

The figures below show QTL maps for each phenotype

out <- scan1(pr.qc, gm$covar["ICI.vs.PBS"], Xcovar=Xcovar, model="binary")

#summary_table<-data.frame(unclass(summary(operm, alpha=c(0.01,  0.05, 0.1))))

plot_lod<-function(out,map){
  for (i in 1:dim(out)[2]){
    #png(filename=paste0("/Users/chenm/Documents/qtl/Jai/",colnames(out)[i],  "_lod.png"))
    
    #par(mar=c(5.1, 6.1, 1.1, 1.1))
    ymx <- maxlod(out) # overall maximum LOD score
    plot(out, gm$gmap, lodcolumn=i, col="slateblue", ylim=c(0, ymx+0.5))
    legend("topright", lwd=2, colnames(out)[i], bg="gray90")
    title(main = colnames(out)[i])
    #for (j in 1: dim(summary_table)[1]){
    #  abline(h=summary_table[j, i],col="red")
    #  text(x=400, y =summary_table[j, i]+0.12, labels = paste("p=", row.names(summary_table)[j]))
    #}
    #dev.off()
  }
}

plot_lod(out,gm$gmap)

Version Author Date
1218e08 Belinda Cornes 2022-02-11

LOD peaks

The table below shows QTL peaks associated with the phenotype. We use the 95% threshold from the permutations to find peaks.

peaks<-find_peaks(out, gm$gmap, threshold=1.5, drop=1.5)

rownames(peaks) <- NULL
peaks[] %>%
  kable(escape = F,align = c("ccccccc")) %>%
  kable_styling("striped", full_width = T) %>%
  column_spec(1, bold=TRUE)
lodindex lodcolumn chr pos lod ci_lo ci_hi
1 ICI.vs.PBS 4 24.212 1.637493 2.373 83.790
1 ICI.vs.PBS 19 3.995 1.654726 3.029 54.895
peaks_mbl <- list()
#corresponding info in Mb
for(i in 1:nrow(peaks)){
  lodindex <- peaks$lodindex[i]
  lodcolumn <- peaks$lodcolumn[i]
  chr <- peaks$chr[i]
  lod <- peaks$lod[i]
  pos <- mapdf$pmapdf[which(mapdf$gmapdf == peaks$pos[i] & mapdf$chr == peaks$chr[i])]
  ci_lo <- mapdf$pmapdf[which(mapdf$gmapdf == peaks$ci_lo[i] & mapdf$chr == peaks$chr[i])]
  ci_hi <- mapdf$pmapdf[which(mapdf$gmapdf == peaks$ci_hi[i] & mapdf$chr == peaks$chr[i])]
  peaks_mb=cbind(lodindex, lodcolumn, chr, pos, lod, ci_lo, ci_hi)
  peaks_mbl[[i]] <- peaks_mb
}
peaks_mba <- do.call(rbind, peaks_mbl)
peaks_mba <- as.data.frame(peaks_mba)
#peaks_mba[,c("chr", "pos", "lod", "ci_lo", "ci_hi")] <- sapply(peaks_mba[,c("chr", "pos", "lod", "ci_lo", "ci_hi")], as.numeric)

rownames(peaks_mba) <- NULL
peaks_mba[] %>%
  kable(escape = F,align = c("ccccccc")) %>%
  kable_styling("striped", full_width = T) %>%
  column_spec(1, bold=TRUE)
lodindex lodcolumn chr pos lod ci_lo ci_hi
1 ICI.vs.PBS 4 45.651631 1.63749305663592 4.369981 154.025994
1 ICI.vs.PBS 19 4.304147 1.65472578904672 3.263752 59.378162

QTL effects

For each peak LOD location we give a list of gene

query_variants <- create_variant_query_func("/Users/corneb/Documents/MyJax/CS/Projects/support.files/qtl2/cc_variants.sqlite")
query_genes <- create_gene_query_func("/Users/corneb/Documents/MyJax/CS/Projects/support.files/qtl2/mouse_genes_mgi.sqlite")

for (i in 1:nrow(peaks)){
#for (i in 1:1){
  #Plot 1
  marker = find_marker(gm$gmap, chr=peaks$chr[i], pos=peaks$pos[i])
  #g <- maxmarg(pr.qc, gm$gmap, chr=peaks$chr[i], pos=peaks$pos[i], return_char=TRUE, minprob = 0.5)
  gp <- g[,marker]
  gp[gp==1] <- "AA"
  gp[gp==2] <- "AB"
  gp[gp==0] <- NA
  #png(filename=paste0("/Users/chenm/Documents/qtl/Jai/","qtl_effect_", i, ".png"))
  #par(mar=c(4.1, 4.1, 1.5, 0.6))
  plot_pxg(gp, gm$covar[,peaks$lodcolumn[i]], ylab=peaks$lodcolumn[i], sort=FALSE)
  title(main = paste("chr", chr=peaks$chr[i], "pos", peaks$pos[i], "(",peaks$lodcolumn[i],")"), line=0.2)
  ##dev.off()

  chr = peaks$chr[i]

# Plot 2
  #coeff <- scan1coef(pr[,chr], cross$pheno[,peaks$lodcolumn[i]], addcovar = addcovar)
  #coeff <- scan1coef(pr[,chr], cross$pheno[,peaks$lodcolumn[i]], Xcovar=Xcovar)
  coeff <- scan1coef(pr.qc[,chr], gm$covar[peaks$lodcolumn[i]], model="binary")
  blup <- scan1blup(pr.qc[,chr], gm$covar[peaks$lodcolumn[i]])
  #plot_coef(coeff, 
  #     gm$gmap[chr], columns=1:2,
  #     bgcolor="gray95", legend="bottomleft", 
  #     main = paste("chr", chr=peaks$chr[i], "pos", peaks$pos[i], "(",peaks$lodcolumn[i]," [scan1coeff])")
  #     )

  plot_coef(blup, 
       gm$gmap[chr], columns=1:2,
       bgcolor="gray95", legend="bottomleft", 
       main = paste("chr", chr=peaks$chr[i], "pos", peaks$pos[i], "(",peaks$lodcolumn[i]," [scan1blup])")
       )
  #last_coef <- unclass(coeff)[nrow(coeff),1:3]
  #for(t in seq(along=last_coef))
  #axis(side=4, at=last_coef[t], names(last_coef)[t], tick=FALSE)


 # Plot 3
  #c2effB <- scan1coef(pr.qc[,chr], gm$covar[peaks$lodcolumn[i]], model="binary", contrasts=cbind(a=c(-1, 0), d=c(0, -1)))
  #c2effBb <- scan1blup(pr.qc[,chr], gm$covar[peaks$lodcolumn[i]], contrasts=cbind(a=c(-1, 0), d=c(0, -1)))
  ##c2effB <- scan1coef(pr[,chr], cross$pheno[,peaks$lodcolumn[i]], addcovar = addcovar, contrasts=cbind(mu=c(1,1,1), a=c(-1, 0, 1), d=c(0, 1, 0)))
  ##c2effB <- scan1coef(pr[,chr], cross$pheno[,peaks$lodcolumn[i]],Xcovar=Xcovar, contrasts=cbind(mu=c(1,1,1), a=c(-1, 0, 1), d=c(0, 1, 0)))
  #plot(c2effB, gm$gmap[chr], columns=1:2,
  #     bgcolor="gray95", legend="bottomleft", 
  #     main = paste("chr", chr=peaks$chr[i], "pos", peaks$pos[i], "(",peaks$lodcolumn[i],")")
  #     )
  #plot(c2effBb, gm$gmap[chr], columns=1:2,
  #     bgcolor="gray95", legend="bottomleft", 
  #     main = paste("chr", chr=peaks$chr[i], "pos", peaks$pos[i], "(",peaks$lodcolumn[i],")")
  #     )
  ##last_coef <- unclass(c2effB)[nrow(c2effB),2:3] # last two coefficients
  ##for(t in seq(along=last_coef))
  ##  axis(side=4, at=last_coef[t], names(last_coef)[t], tick=FALSE)


  #Table 1
  chr = peaks_mba$chr[i]
  start=as.numeric(peaks_mba$ci_lo[i])
  end=as.numeric(peaks_mba$ci_hi[i])

  genesgss = query_genes(chr, start, end)

  rownames(genesgss) <- NULL
  genesgss$strand_old = genesgss$strand
  genesgss$strand[genesgss$strand=="+"] <- "positive"
  genesgss$strand[genesgss$strand=="-"] <- "negative"

  #genesgss <- 
  #table <- 
  #genesgss[,c("chr","type","start","stop","strand","ID","Name","Dbxref","gene_id","mgi_type","description")] %>%
  #kable(escape = F,align = c("ccccccccccc")) %>%
  #kable_styling("striped", full_width = T) #%>% 
  #cat #%>%
  #column_spec(1, bold=TRUE)
#
  #print(kable(genesgss[,c("chr","type","start","stop","strand","ID","Name","Dbxref","gene_id","mgi_type","description")], escape = F,align = c("ccccccccccc")))

  print(kable(genesgss[,c("chr","type","start","stop","strand","ID","Name","Dbxref","gene_id","mgi_type","description")], "html") %>% kable_styling("striped", full_width = T))

  #table
  

}

Version Author Date
1218e08 Belinda Cornes 2022-02-11

Version Author Date
1218e08 Belinda Cornes 2022-02-11
chr type start stop strand ID Name Dbxref gene_id mgi_type description
4 gene 4.377272 4.418084 positive MGI_C57BL6J_5592166 Gm33007 NCBI_Gene:102635747 MGI:5592166 lncRNA gene predicted gene, 33007
4 gene 4.523523 4.543169 positive MGI_C57BL6J_5592216 Gm33057 NCBI_Gene:102635811 MGI:5592216 lncRNA gene predicted gene, 33057
4 pseudogene 4.527774 4.529458 negative MGI_C57BL6J_3650485 Gm11780 NCBI_Gene:622019,ENSEMBL:ENSMUSG00000085155 MGI:3650485 pseudogene predicted gene 11780
4 gene 4.543272 4.564877 positive MGI_C57BL6J_5592341 Gm33182 NCBI_Gene:102635983 MGI:5592341 lncRNA gene predicted gene, 33182
4 gene 4.622587 4.625490 positive MGI_C57BL6J_5592418 Gm33259 NCBI_Gene:102636090 MGI:5592418 lncRNA gene predicted gene, 33259
4 gene 4.729573 4.729704 positive MGI_C57BL6J_5456213 Gm26436 ENSEMBL:ENSMUSG00000095971 MGI:5456213 snoRNA gene predicted gene, 26436
4 gene 4.762484 4.793355 negative MGI_C57BL6J_1915720 Impad1 NCBI_Gene:242291,ENSEMBL:ENSMUSG00000066324 MGI:1915720 protein coding gene inositol monophosphatase domain containing 1
4 pseudogene 4.944226 4.944855 negative MGI_C57BL6J_5011118 Gm18933 NCBI_Gene:100417981 MGI:5011118 pseudogene predicted gene, 18933
4 pseudogene 4.978507 4.978874 negative MGI_C57BL6J_3650487 Gm11779 ENSEMBL:ENSMUSG00000083228 MGI:3650487 pseudogene predicted gene 11779
4 gene 5.545238 5.551223 negative MGI_C57BL6J_3651017 Gm11782 ENSEMBL:ENSMUSG00000087099 MGI:3651017 lncRNA gene predicted gene 11782
4 pseudogene 5.602924 5.603395 negative MGI_C57BL6J_3650702 Gm11781 ENSEMBL:ENSMUSG00000084237 MGI:3650702 pseudogene predicted gene 11781
4 gene 5.632328 5.642284 positive MGI_C57BL6J_1921122 4930423M02Rik NCBI_Gene:73872,ENSEMBL:ENSMUSG00000086066 MGI:1921122 lncRNA gene RIKEN cDNA 4930423M02 gene
4 gene 5.644079 6.108223 positive MGI_C57BL6J_1916593 Fam110b NCBI_Gene:242297,ENSEMBL:ENSMUSG00000049119 MGI:1916593 protein coding gene family with sequence similarity 110, member B
4 gene 5.687677 5.687802 negative MGI_C57BL6J_5454114 Gm24337 ENSEMBL:ENSMUSG00000077392 MGI:5454114 snoRNA gene predicted gene, 24337
4 pseudogene 5.854317 5.855498 negative MGI_C57BL6J_3651076 Gm11796 NCBI_Gene:669309,ENSEMBL:ENSMUSG00000083232 MGI:3651076 pseudogene predicted gene 11796
4 pseudogene 6.025065 6.025846 negative MGI_C57BL6J_5010343 Gm18158 NCBI_Gene:100416552 MGI:5010343 pseudogene predicted gene, 18158
4 pseudogene 6.069874 6.070627 positive MGI_C57BL6J_3651074 Gm11797 NCBI_Gene:100416839,ENSEMBL:ENSMUSG00000084360 MGI:3651074 pseudogene predicted gene 11797
4 gene 6.191098 6.221688 positive MGI_C57BL6J_1915303 Ubxn2b NCBI_Gene:68053,ENSEMBL:ENSMUSG00000028243 MGI:1915303 protein coding gene UBX domain protein 2B
4 pseudogene 6.260091 6.260965 negative MGI_C57BL6J_3651068 Gm11798 ENSEMBL:ENSMUSG00000080961 MGI:3651068 pseudogene predicted gene 11798
4 gene 6.264113 6.275633 negative MGI_C57BL6J_106091 Cyp7a1 NCBI_Gene:13122,ENSEMBL:ENSMUSG00000028240 MGI:106091 protein coding gene cytochrome P450, family 7, subfamily a, polypeptide 1
4 gene 6.352105 6.357615 negative MGI_C57BL6J_1918889 4930430E12Rik NCBI_Gene:71639,ENSEMBL:ENSMUSG00000085295 MGI:1918889 lncRNA gene RIKEN cDNA 4930430E12 gene
4 gene 6.365650 6.408423 positive MGI_C57BL6J_1337026 Sdcbp NCBI_Gene:53378,ENSEMBL:ENSMUSG00000028249 MGI:1337026 protein coding gene syndecan binding protein
4 gene 6.378018 6.378292 positive MGI_C57BL6J_5610917 Gm37689 ENSEMBL:ENSMUSG00000104347 MGI:5610917 unclassified gene predicted gene, 37689
4 gene 6.396207 6.454673 negative MGI_C57BL6J_1341864 Nsmaf NCBI_Gene:18201,ENSEMBL:ENSMUSG00000028245 MGI:1341864 protein coding gene neutral sphingomyelinase (N-SMase) activation associated factor
4 pseudogene 6.507914 6.508455 negative MGI_C57BL6J_3650653 Gm11803 NCBI_Gene:108168944,ENSEMBL:ENSMUSG00000081913 MGI:3650653 pseudogene predicted gene 11803
4 pseudogene 6.512952 6.540306 positive MGI_C57BL6J_3650652 Gm11801 NCBI_Gene:101055960,ENSEMBL:ENSMUSG00000081388 MGI:3650652 pseudogene predicted gene 11801
4 gene 6.634164 6.634295 negative MGI_C57BL6J_5452250 Gm22473 ENSEMBL:ENSMUSG00000077302 MGI:5452250 snoRNA gene predicted gene, 22473
4 gene 6.686353 6.991557 negative MGI_C57BL6J_2181659 Tox NCBI_Gene:252838,ENSEMBL:ENSMUSG00000041272 MGI:2181659 protein coding gene thymocyte selection-associated high mobility group box
4 gene 6.688169 6.721854 positive MGI_C57BL6J_3650651 Gm11802 NCBI_Gene:102636258,ENSEMBL:ENSMUSG00000086052 MGI:3650651 lncRNA gene predicted gene 11802
4 gene 6.941893 6.942298 negative MGI_C57BL6J_1916459 2610024J18Rik NA NA unclassified gene RIKEN cDNA 2610024J18 gene
4 pseudogene 7.039047 7.039514 negative MGI_C57BL6J_3650654 Gm11804 ENSEMBL:ENSMUSG00000083023 MGI:3650654 pseudogene predicted gene 11804
4 gene 7.133973 7.162454 positive MGI_C57BL6J_5592621 Gm33462 NCBI_Gene:102636377 MGI:5592621 lncRNA gene predicted gene, 33462
4 gene 7.166908 7.175024 positive MGI_C57BL6J_5592698 Gm33539 NCBI_Gene:102636484 MGI:5592698 lncRNA gene predicted gene, 33539
4 gene 7.192184 7.215586 positive MGI_C57BL6J_5592805 Gm33646 NCBI_Gene:102636636 MGI:5592805 lncRNA gene predicted gene, 33646
4 gene 7.560688 7.573801 positive MGI_C57BL6J_1918760 8430436N08Rik NCBI_Gene:71510,ENSEMBL:ENSMUSG00000086070 MGI:1918760 lncRNA gene RIKEN cDNA 8430436N08 gene
4 gene 7.581585 7.648909 negative MGI_C57BL6J_5592911 Gm33752 NCBI_Gene:102636773 MGI:5592911 lncRNA gene predicted gene, 33752
4 gene 7.759670 7.763930 positive MGI_C57BL6J_3650854 Gm11795 ENSEMBL:ENSMUSG00000085630 MGI:3650854 lncRNA gene predicted gene 11795
4 pseudogene 7.763264 7.763500 negative MGI_C57BL6J_3650853 Gm11794 ENSEMBL:ENSMUSG00000082024 MGI:3650853 pseudogene predicted gene 11794
4 gene 7.820916 7.821047 positive MGI_C57BL6J_5453637 Gm23860 ENSEMBL:ENSMUSG00000094771 MGI:5453637 snoRNA gene predicted gene, 23860
4 pseudogene 8.118620 8.119736 positive MGI_C57BL6J_3650447 Gm11800 ENSEMBL:ENSMUSG00000083068 MGI:3650447 pseudogene predicted gene 11800
4 gene 8.141493 8.239041 negative MGI_C57BL6J_88253 Car8 NCBI_Gene:12319,ENSEMBL:ENSMUSG00000041261 MGI:88253 protein coding gene carbonic anhydrase 8
4 pseudogene 8.166894 8.167353 negative MGI_C57BL6J_3650446 Gm11799 ENSEMBL:ENSMUSG00000079993 MGI:3650446 pseudogene predicted gene 11799
4 gene 8.235582 8.235682 positive MGI_C57BL6J_5455132 Gm25355 ENSEMBL:ENSMUSG00000096388 MGI:5455132 miRNA gene predicted gene, 25355
4 gene 8.374934 8.419717 negative MGI_C57BL6J_5625137 Gm42252 NCBI_Gene:105247092 MGI:5625137 lncRNA gene predicted gene, 42252
4 gene 8.438522 8.454247 negative MGI_C57BL6J_5610614 Gm37386 ENSEMBL:ENSMUSG00000103127 MGI:5610614 unclassified gene predicted gene, 37386
4 pseudogene 8.456166 8.456498 negative MGI_C57BL6J_3652275 Gm11810 NCBI_Gene:100039478,ENSEMBL:ENSMUSG00000082151 MGI:3652275 pseudogene predicted gene 11810
4 pseudogene 8.461492 8.467480 positive MGI_C57BL6J_5010283 Gm18098 NCBI_Gene:100416404 MGI:5010283 pseudogene predicted gene, 18098
4 gene 8.535587 8.607778 positive MGI_C57BL6J_1928750 Rab2a NCBI_Gene:59021,ENSEMBL:ENSMUSG00000047187 MGI:1928750 protein coding gene RAB2A, member RAS oncogene family
4 gene 8.582776 8.586327 positive MGI_C57BL6J_2445209 D130047N11Rik NA NA unclassified gene RIKEN cDNA D130047N11 gene
4 gene 8.597047 8.599712 positive MGI_C57BL6J_2441912 C530036F05Rik NA NA unclassified gene RIKEN cDNA C530036F05 gene
4 gene 8.635181 8.646297 negative MGI_C57BL6J_5625138 Gm42253 NCBI_Gene:105247093 MGI:5625138 lncRNA gene predicted gene, 42253
4 gene 8.646963 8.649081 negative MGI_C57BL6J_3648337 Gm8273 NCBI_Gene:666752 MGI:3648337 unclassified gene predicted gene 8273
4 pseudogene 8.672633 8.673582 negative MGI_C57BL6J_3650709 Gm11809 NCBI_Gene:666760,ENSEMBL:ENSMUSG00000082122 MGI:3650709 pseudogene predicted gene 11809
4 gene 8.690406 8.868449 positive MGI_C57BL6J_2444748 Chd7 NCBI_Gene:320790,ENSEMBL:ENSMUSG00000041235 MGI:2444748 protein coding gene chromodomain helicase DNA binding protein 7
4 gene 8.720972 8.731950 positive MGI_C57BL6J_5826478 Gm46841 NCBI_Gene:108168925 MGI:5826478 protein coding gene predicted gene, 46841
4 gene 8.901941 8.910658 negative MGI_C57BL6J_5826479 Gm46842 NCBI_Gene:108168926 MGI:5826479 lncRNA gene predicted gene, 46842
4 pseudogene 8.941259 8.941695 positive MGI_C57BL6J_3652274 Rps18-ps2 NCBI_Gene:666782,ENSEMBL:ENSMUSG00000083786 MGI:3652274 pseudogene ribosomal protein S18, pseudogene 2
4 gene 9.006056 9.008559 negative MGI_C57BL6J_5593587 Gm34428 NCBI_Gene:102637677 MGI:5593587 lncRNA gene predicted gene, 34428
4 gene 9.128924 9.142887 negative MGI_C57BL6J_5593447 Gm34288 NCBI_Gene:102637496 MGI:5593447 lncRNA gene predicted gene, 34288
4 gene 9.144752 9.451691 positive MGI_C57BL6J_1921688 Clvs1 NCBI_Gene:74438,ENSEMBL:ENSMUSG00000041216 MGI:1921688 protein coding gene clavesin 1
4 gene 9.210003 9.210108 positive MGI_C57BL6J_5453200 Gm23423 ENSEMBL:ENSMUSG00000075958 MGI:5453200 snRNA gene predicted gene, 23423
4 gene 9.267323 9.269915 negative MGI_C57BL6J_5477042 Gm26548 ENSEMBL:ENSMUSG00000097094 MGI:5477042 lncRNA gene predicted gene, 26548
4 gene 9.282226 9.287510 negative MGI_C57BL6J_3650294 Gm11816 NCBI_Gene:102638175,ENSEMBL:ENSMUSG00000086233 MGI:3650294 lncRNA gene predicted gene 11816
4 gene 9.395379 9.400975 positive MGI_C57BL6J_2443698 D130060J02Rik NA NA unclassified non-coding RNA gene RIKEN cDNA D130060J02 gene
4 gene 9.431961 9.447199 negative MGI_C57BL6J_3650295 Gm11817 ENSEMBL:ENSMUSG00000087564 MGI:3650295 lncRNA gene predicted gene 11817
4 gene 9.448069 9.669344 negative MGI_C57BL6J_1914186 Asph NCBI_Gene:65973,ENSEMBL:ENSMUSG00000028207 MGI:1914186 protein coding gene aspartate-beta-hydroxylase
4 pseudogene 9.569963 9.570493 negative MGI_C57BL6J_5011315 Gm19130 NCBI_Gene:100418303 MGI:5011315 pseudogene predicted gene, 19130
4 gene 9.669279 9.669350 positive MGI_C57BL6J_5455454 Gm25677 ENSEMBL:ENSMUSG00000092724 MGI:5455454 miRNA gene predicted gene, 25677
4 gene 9.695645 9.695807 negative MGI_C57BL6J_5453929 Gm24152 ENSEMBL:ENSMUSG00000064698 MGI:5453929 snRNA gene predicted gene, 24152
4 gene 9.748386 9.751427 positive MGI_C57BL6J_5594106 Gm34947 NCBI_Gene:102638364 MGI:5594106 lncRNA gene predicted gene, 34947
4 gene 9.770585 9.823411 positive MGI_C57BL6J_2443490 4930412C18Rik NCBI_Gene:320152,ENSEMBL:ENSMUSG00000085558 MGI:2443490 lncRNA gene RIKEN cDNA 4930412C18 gene
4 gene 9.830338 9.840397 negative MGI_C57BL6J_5625139 Gm42254 NCBI_Gene:105247094 MGI:5625139 lncRNA gene predicted gene, 42254
4 gene 9.844372 9.862345 positive MGI_C57BL6J_95689 Gdf6 NCBI_Gene:242316,ENSEMBL:ENSMUSG00000051279 MGI:95689 protein coding gene growth differentiation factor 6
4 pseudogene 9.915965 9.917635 negative MGI_C57BL6J_1921912 4930448K20Rik NCBI_Gene:74662,ENSEMBL:ENSMUSG00000082843 MGI:1921912 pseudogene RIKEN cDNA 4930448K20 gene
4 pseudogene 9.958208 9.959130 positive MGI_C57BL6J_3650692 Gm11834 ENSEMBL:ENSMUSG00000084095 MGI:3650692 pseudogene predicted gene 11834
4 pseudogene 9.959354 9.960016 positive MGI_C57BL6J_3650540 Gm11835 ENSEMBL:ENSMUSG00000082501 MGI:3650540 pseudogene predicted gene 11835
4 gene 10.147612 10.158241 positive MGI_C57BL6J_5594167 Gm35008 NCBI_Gene:102638443 MGI:5594167 lncRNA gene predicted gene, 35008
4 gene 10.392712 10.409934 negative MGI_C57BL6J_5826516 Gm46879 NCBI_Gene:108168991 MGI:5826516 lncRNA gene predicted gene, 46879
4 pseudogene 10.438335 10.439841 negative MGI_C57BL6J_3650512 Gm11814 NCBI_Gene:666840,ENSEMBL:ENSMUSG00000084215 MGI:3650512 pseudogene predicted gene 11814
4 gene 10.479962 10.797811 negative MGI_C57BL6J_1920874 1700123O12Rik NCBI_Gene:73624,ENSEMBL:ENSMUSG00000086080 MGI:1920874 lncRNA gene RIKEN cDNA 1700123O12 gene
4 gene 10.487956 10.489362 negative MGI_C57BL6J_3650511 Gm11815 ENSEMBL:ENSMUSG00000086455 MGI:3650511 lncRNA gene predicted gene 11815
4 pseudogene 10.580812 10.581102 positive MGI_C57BL6J_3649543 Gm11813 ENSEMBL:ENSMUSG00000081361 MGI:3649543 pseudogene predicted gene 11813
4 pseudogene 10.813529 10.814772 positive MGI_C57BL6J_3652000 Gm12920 NCBI_Gene:383991,ENSEMBL:ENSMUSG00000083997 MGI:3652000 pseudogene predicted gene 12920
4 gene 10.845500 10.845630 negative MGI_C57BL6J_4441436 Mir3471-1 miRBase:MI0014699,NCBI_Gene:100499521,ENSEMBL:ENSMUSG00000092880 MGI:4441436 miRNA gene microRNA 3471-1
4 pseudogene 10.848387 10.849110 positive MGI_C57BL6J_3652005 Gm12918 NCBI_Gene:100039656,ENSEMBL:ENSMUSG00000066315 MGI:3652005 pseudogene predicted gene 12918
4 pseudogene 10.853714 10.855714 positive MGI_C57BL6J_3652001 Gm12919 NCBI_Gene:545589,ENSEMBL:ENSMUSG00000083220 MGI:3652001 pseudogene predicted gene 12919
4 gene 10.874064 10.874170 positive MGI_C57BL6J_4414029 n-TSaga9 NCBI_Gene:102467375,ENSEMBL:ENSMUSG00000106355 MGI:4414029 tRNA gene nuclear encoded tRNA serine 9 (anticodon AGA)
4 gene 10.874251 10.899425 positive MGI_C57BL6J_1914407 2610301B20Rik NCBI_Gene:67157,ENSEMBL:ENSMUSG00000059482 MGI:1914407 protein coding gene RIKEN cDNA 2610301B20 gene
4 pseudogene 10.946584 10.947118 positive MGI_C57BL6J_3649802 Rps11-ps3 NCBI_Gene:383992,ENSEMBL:ENSMUSG00000081715 MGI:3649802 pseudogene ribosomal protein S11, pseudogene 3
4 pseudogene 10.987740 10.990315 positive MGI_C57BL6J_3780569 Gm2401 NCBI_Gene:102638891 MGI:3780569 pseudogene predicted gene 2401
4 gene 10.988662 11.007927 negative MGI_C57BL6J_1919051 Plekhf2 NCBI_Gene:71801,ENSEMBL:ENSMUSG00000049969 MGI:1919051 protein coding gene pleckstrin homology domain containing, family F (with FYVE domain) member 2
4 gene 11.010449 11.026700 negative MGI_C57BL6J_5826480 Gm46843 NCBI_Gene:108168928 MGI:5826480 lncRNA gene predicted gene, 46843
4 gene 11.031796 11.049868 negative MGI_C57BL6J_5594588 Gm35429 NCBI_Gene:102639007 MGI:5594588 lncRNA gene predicted gene, 35429
4 gene 11.051042 11.076246 negative MGI_C57BL6J_1924197 Ndufaf6 NCBI_Gene:76947,ENSEMBL:ENSMUSG00000050323 MGI:1924197 protein coding gene NADH:ubiquinone oxidoreductase complex assembly factor 6
4 gene 11.122805 11.126998 positive MGI_C57BL6J_3649801 Gm11827 NCBI_Gene:100503518,ENSEMBL:ENSMUSG00000086765 MGI:3649801 lncRNA gene predicted gene 11827
4 pseudogene 11.133218 11.133806 positive MGI_C57BL6J_3649804 Gm11829 NCBI_Gene:546828,ENSEMBL:ENSMUSG00000083025 MGI:3649804 pseudogene predicted gene 11829
4 gene 11.134097 11.134182 positive MGI_C57BL6J_3629642 Mir684-2 miRBase:MI0004648,NCBI_Gene:735261,ENSEMBL:ENSMUSG00000105333 MGI:3629642 miRNA gene microRNA 684-2
4 pseudogene 11.144710 11.145270 positive MGI_C57BL6J_3649825 Gm11830 ENSEMBL:ENSMUSG00000081490 MGI:3649825 pseudogene predicted gene 11830
4 gene 11.156431 11.174379 positive MGI_C57BL6J_1926609 Trp53inp1 NCBI_Gene:60599,ENSEMBL:ENSMUSG00000028211 MGI:1926609 protein coding gene transformation related protein 53 inducible nuclear protein 1
4 gene 11.175962 11.191230 negative MGI_C57BL6J_3041215 A630034I12Rik NCBI_Gene:329790 MGI:3041215 lncRNA gene RIKEN cDNA A630034I12 gene
4 gene 11.190298 11.204779 positive MGI_C57BL6J_1329034 Ccne2 NCBI_Gene:12448,ENSEMBL:ENSMUSG00000028212 MGI:1329034 protein coding gene cyclin E2
4 gene 11.199158 11.254265 negative MGI_C57BL6J_1919906 Ints8 NCBI_Gene:72656,ENSEMBL:ENSMUSG00000040738 MGI:1919906 protein coding gene integrator complex subunit 8
4 gene 11.261315 11.322505 negative MGI_C57BL6J_2685869 Dpy19l4 NCBI_Gene:381510,ENSEMBL:ENSMUSG00000045205 MGI:2685869 protein coding gene dpy-19-like 4 (C. elegans)
4 gene 11.279265 11.279419 negative MGI_C57BL6J_5452717 Gm22940 ENSEMBL:ENSMUSG00000089185 MGI:5452717 snRNA gene predicted gene, 22940
4 gene 11.321944 11.342953 positive MGI_C57BL6J_5477157 Gm26663 ENSEMBL:ENSMUSG00000097019 MGI:5477157 lncRNA gene predicted gene, 26663
4 gene 11.331933 11.386783 negative MGI_C57BL6J_1917326 Esrp1 NCBI_Gene:207920,ENSEMBL:ENSMUSG00000040728 MGI:1917326 protein coding gene epithelial splicing regulatory protein 1
4 gene 11.387132 11.389412 positive MGI_C57BL6J_5594790 Gm35631 NCBI_Gene:102639284 MGI:5594790 lncRNA gene predicted gene, 35631
4 pseudogene 11.396715 11.401824 positive MGI_C57BL6J_3649777 Gm11821 NCBI_Gene:634834,ENSEMBL:ENSMUSG00000081884 MGI:3649777 pseudogene predicted gene 11821
4 pseudogene 11.420350 11.420764 negative MGI_C57BL6J_3649778 Gm11822 ENSEMBL:ENSMUSG00000082255 MGI:3649778 pseudogene predicted gene 11822
4 gene 11.485949 11.551143 positive MGI_C57BL6J_1913435 Virma NCBI_Gene:66185,ENSEMBL:ENSMUSG00000040720 MGI:1913435 protein coding gene vir like m6A methyltransferase associated
4 gene 11.501456 11.502839 negative MGI_C57BL6J_3650069 Gm11831 ENSEMBL:ENSMUSG00000086625 MGI:3650069 lncRNA gene predicted gene 11831
4 gene 11.551434 11.558931 negative MGI_C57BL6J_5594852 Gm35693 NCBI_Gene:102639363 MGI:5594852 lncRNA gene predicted gene, 35693
4 gene 11.558920 11.615808 positive MGI_C57BL6J_3605986 Rad54b NCBI_Gene:623474,ENSEMBL:ENSMUSG00000078773 MGI:3605986 protein coding gene RAD54 homolog B (S. cerevisiae)
4 gene 11.579662 11.587802 positive MGI_C57BL6J_5301008 Fsbp NCBI_Gene:100503583,ENSEMBL:ENSMUSG00000094595 MGI:5301008 protein coding gene fibrinogen silencer binding protein
4 gene 11.610907 11.615441 negative MGI_C57BL6J_3650310 Gm11832 NCBI_Gene:102639547,ENSEMBL:ENSMUSG00000086103 MGI:3650310 lncRNA gene predicted gene 11832
4 pseudogene 11.649613 11.650530 negative MGI_C57BL6J_3650311 Gm11833 NCBI_Gene:100039862,ENSEMBL:ENSMUSG00000084046 MGI:3650311 pseudogene predicted gene 11833
4 gene 11.663967 11.676178 negative MGI_C57BL6J_5595043 Gm35884 NCBI_Gene:102639615 MGI:5595043 lncRNA gene predicted gene, 35884
4 gene 11.704447 11.714993 positive MGI_C57BL6J_99844 Gem NCBI_Gene:14579,ENSEMBL:ENSMUSG00000028214 MGI:99844 protein coding gene GTP binding protein (gene overexpressed in skeletal muscle)
4 gene 11.758147 11.817905 positive MGI_C57BL6J_1095414 Cdh17 NCBI_Gene:12557,ENSEMBL:ENSMUSG00000028217 MGI:1095414 protein coding gene cadherin 17
4 gene 11.928424 11.928739 positive MGI_C57BL6J_5452254 Gm22477 ENSEMBL:ENSMUSG00000084518 MGI:5452254 unclassified non-coding RNA gene predicted gene, 22477
4 gene 11.948887 11.948950 positive MGI_C57BL6J_5454779 Gm25002 ENSEMBL:ENSMUSG00000080663 MGI:5454779 miRNA gene predicted gene, 25002
4 gene 11.958183 11.966452 negative MGI_C57BL6J_2685870 Pdp1 NCBI_Gene:381511,ENSEMBL:ENSMUSG00000049225 MGI:2685870 protein coding gene pyruvate dehyrogenase phosphatase catalytic subunit 1
4 gene 11.966565 11.994295 positive MGI_C57BL6J_1923915 1700123M08Rik NCBI_Gene:100503636,ENSEMBL:ENSMUSG00000085614 MGI:1923915 lncRNA gene RIKEN cDNA 1700123M08 gene
4 gene 11.979560 11.981265 negative MGI_C57BL6J_3642593 Gm10604 NA NA protein coding gene predicted gene 10604
4 gene 11.980669 11.988471 positive MGI_C57BL6J_5477389 Gm26895 ENSEMBL:ENSMUSG00000097459 MGI:5477389 lncRNA gene predicted gene, 26895
4 gene 11.999474 12.018378 negative MGI_C57BL6J_3651502 Gm11840 NCBI_Gene:105247602,ENSEMBL:ENSMUSG00000085027 MGI:3651502 lncRNA gene predicted gene 11840
4 gene 12.002494 12.005785 positive MGI_C57BL6J_5625140 Gm42255 NCBI_Gene:105247096 MGI:5625140 lncRNA gene predicted gene, 42255
4 gene 12.013614 12.016141 positive MGI_C57BL6J_1921631 4932430A15Rik NA NA unclassified gene RIKEN cDNA 4932430A15 gene
4 gene 12.013960 12.016161 positive MGI_C57BL6J_5826481 Gm46844 NCBI_Gene:108168929 MGI:5826481 lncRNA gene predicted gene, 46844
4 gene 12.027505 12.040894 positive MGI_C57BL6J_3651165 Gm11842 ENSEMBL:ENSMUSG00000085467 MGI:3651165 lncRNA gene predicted gene 11842
4 gene 12.039355 12.090020 negative MGI_C57BL6J_1923928 Tmem67 NCBI_Gene:329795,ENSEMBL:ENSMUSG00000049488 MGI:1923928 protein coding gene transmembrane protein 67
4 gene 12.089370 12.096271 positive MGI_C57BL6J_1924854 Rbm12b2 NCBI_Gene:77604,ENSEMBL:ENSMUSG00000052137 MGI:1924854 protein coding gene RNA binding motif protein 12 B2
4 pseudogene 12.114084 12.116438 positive MGI_C57BL6J_3651162 Gm11839 NCBI_Gene:230010,ENSEMBL:ENSMUSG00000083246 MGI:3651162 pseudogene predicted gene 11839
4 pseudogene 12.125090 12.127449 positive MGI_C57BL6J_3651164 Gm11841 NCBI_Gene:623671,ENSEMBL:ENSMUSG00000081593 MGI:3651164 pseudogene predicted gene 11841
4 pseudogene 12.130821 12.133257 negative MGI_C57BL6J_3651166 Gm11843 NCBI_Gene:101056106,ENSEMBL:ENSMUSG00000082676 MGI:3651166 pseudogene predicted gene 11843
4 gene 12.138957 12.148922 positive MGI_C57BL6J_1919647 Rbm12b1 NCBI_Gene:72397,ENSEMBL:ENSMUSG00000046667 MGI:1919647 protein coding gene RNA binding motif protein 12 B1
4 gene 12.153142 12.172024 negative MGI_C57BL6J_1915349 Fam92a NCBI_Gene:68099,ENSEMBL:ENSMUSG00000028218 MGI:1915349 protein coding gene family with sequence similarity 92, member A
4 gene 12.155733 12.159422 positive MGI_C57BL6J_5826482 Gm46845 NCBI_Gene:108168930 MGI:5826482 lncRNA gene predicted gene, 46845
4 gene 12.176904 12.186270 positive MGI_C57BL6J_5826483 Gm46846 NCBI_Gene:108168931 MGI:5826483 lncRNA gene predicted gene, 46846
4 pseudogene 12.232772 12.238024 positive MGI_C57BL6J_3651787 Gm11847 NCBI_Gene:545592,ENSEMBL:ENSMUSG00000060989 MGI:3651787 pseudogene predicted gene 11847
4 gene 12.271399 12.314583 positive MGI_C57BL6J_3651794 Gm11846 ENSEMBL:ENSMUSG00000085909 MGI:3651794 lncRNA gene predicted gene 11846
4 gene 12.597388 12.671843 positive MGI_C57BL6J_5611213 Gm37985 ENSEMBL:ENSMUSG00000104211 MGI:5611213 unclassified gene predicted gene, 37985
4 gene 12.812706 12.812812 positive MGI_C57BL6J_4422047 n-R5s182 ENSEMBL:ENSMUSG00000065823 MGI:4422047 rRNA gene nuclear encoded rRNA 5S 182
4 gene 12.906837 12.983553 positive MGI_C57BL6J_3650048 Triqk NCBI_Gene:208820,ENSEMBL:ENSMUSG00000055963 MGI:3650048 protein coding gene triple QxxK/R motif containing
4 gene 12.981670 13.025788 positive MGI_C57BL6J_5625141 Gm42256 NCBI_Gene:105247097 MGI:5625141 lncRNA gene predicted gene, 42256
4 gene 13.076140 13.108752 positive MGI_C57BL6J_3650049 Gm11820 NCBI_Gene:102640073,ENSEMBL:ENSMUSG00000086227 MGI:3650049 lncRNA gene predicted gene 11820
4 gene 13.108782 13.117434 positive MGI_C57BL6J_5826484 Gm46847 NCBI_Gene:108168932 MGI:5826484 lncRNA gene predicted gene, 46847
4 gene 13.266985 13.267050 negative MGI_C57BL6J_5456027 Gm26250 ENSEMBL:ENSMUSG00000080359 MGI:5456027 miRNA gene predicted gene, 26250
4 gene 13.282641 13.307489 positive MGI_C57BL6J_5826517 Gm46880 NCBI_Gene:108168992 MGI:5826517 lncRNA gene predicted gene, 46880
4 pseudogene 13.444763 13.447593 negative MGI_C57BL6J_5012217 Gm20032 NCBI_Gene:102639470 MGI:5012217 pseudogene predicted gene, 20032
4 pseudogene 13.444770 13.445141 positive MGI_C57BL6J_3650050 Gm11819 ENSEMBL:ENSMUSG00000081327 MGI:3650050 pseudogene predicted gene 11819
4 pseudogene 13.482704 13.483230 negative MGI_C57BL6J_3651142 Gm11826 NCBI_Gene:100039988,ENSEMBL:ENSMUSG00000083328 MGI:3651142 pseudogene predicted gene 11826
4 gene 13.515142 13.519253 negative MGI_C57BL6J_5826518 Gm46881 NCBI_Gene:108168993 MGI:5826518 lncRNA gene predicted gene, 46881
4 gene 13.561170 13.586612 negative MGI_C57BL6J_5595647 Gm36488 NCBI_Gene:102640424 MGI:5595647 lncRNA gene predicted gene, 36488
4 gene 13.585545 13.595709 positive MGI_C57BL6J_5595597 Gm36438 NCBI_Gene:102640354 MGI:5595597 lncRNA gene predicted gene, 36438
4 pseudogene 13.606034 13.606769 positive MGI_C57BL6J_3651186 Gm11825 ENSEMBL:ENSMUSG00000081063 MGI:3651186 pseudogene predicted gene 11825
4 gene 13.609845 13.668730 negative MGI_C57BL6J_1918931 0610009K14Rik NA NA unclassified gene RIKEN cDNA 0610009K14 gene
4 gene 13.622643 13.622763 negative MGI_C57BL6J_5452939 Gm23162 ENSEMBL:ENSMUSG00000092822 MGI:5452939 miRNA gene predicted gene, 23162
4 gene 13.743180 13.895056 positive MGI_C57BL6J_104793 Runx1t1 NCBI_Gene:12395,ENSEMBL:ENSMUSG00000006586 MGI:104793 protein coding gene RUNX1 translocation partner 1
4 gene 13.773907 13.780279 positive MGI_C57BL6J_2442520 C130062D02Rik NA NA unclassified gene RIKEN cDNA C130062D02 gene
4 gene 13.854782 13.855750 positive MGI_C57BL6J_1921037 4833406L22Rik NA NA unclassified gene RIKEN cDNA 4833406L22 gene
4 gene 13.919954 13.995193 negative MGI_C57BL6J_3651314 Gm11823 NCBI_Gene:329797,ENSEMBL:ENSMUSG00000086927 MGI:3651314 lncRNA gene predicted gene 11823
4 gene 14.079809 14.079940 negative MGI_C57BL6J_5453845 Gm24068 ENSEMBL:ENSMUSG00000077701 MGI:5453845 snoRNA gene predicted gene, 24068
4 pseudogene 14.170063 14.170911 positive MGI_C57BL6J_3651313 Gm11824 NCBI_Gene:433687,ENSEMBL:ENSMUSG00000082128 MGI:3651313 pseudogene predicted gene 11824
4 gene 14.212012 14.291309 negative MGI_C57BL6J_3780728 Gm2560 NCBI_Gene:100040030 MGI:3780728 lncRNA gene predicted gene 2560
4 gene 14.219496 14.237450 negative MGI_C57BL6J_1920849 1700120G11Rik ENSEMBL:ENSMUSG00000086068 MGI:1920849 lncRNA gene RIKEN cDNA 1700120G11 gene
4 gene 14.239618 14.239744 positive MGI_C57BL6J_5454685 Gm24908 ENSEMBL:ENSMUSG00000087919 MGI:5454685 snoRNA gene predicted gene, 24908
4 pseudogene 14.433848 14.434481 positive MGI_C57BL6J_3650063 Gm11836 NCBI_Gene:433688,ENSEMBL:ENSMUSG00000081239 MGI:3650063 pseudogene predicted gene 11836
4 gene 14.502430 14.621973 negative MGI_C57BL6J_2384791 Slc26a7 NCBI_Gene:208890,ENSEMBL:ENSMUSG00000040569 MGI:2384791 protein coding gene solute carrier family 26, member 7
4 gene 14.525864 14.526197 positive MGI_C57BL6J_1917406 2310046G18Rik NA NA unclassified gene RIKEN cDNA 2310046G18 gene
4 gene 14.623620 14.801379 negative MGI_C57BL6J_1920564 Lrrc69 NCBI_Gene:73314,ENSEMBL:ENSMUSG00000023151 MGI:1920564 protein coding gene leucine rich repeat containing 69
4 pseudogene 14.766335 14.766565 positive MGI_C57BL6J_3650938 Gm11838 ENSEMBL:ENSMUSG00000083280 MGI:3650938 pseudogene predicted gene 11838
4 gene 14.809498 14.826587 negative MGI_C57BL6J_1919451 Otud6b NCBI_Gene:72201,ENSEMBL:ENSMUSG00000040550 MGI:1919451 protein coding gene OTU domain containing 6B
4 gene 14.864076 14.915260 positive MGI_C57BL6J_1919769 Pip4p2 NCBI_Gene:72519,ENSEMBL:ENSMUSG00000028221 MGI:1919769 protein coding gene phosphatidylinositol-4,5-bisphosphate 4-phosphatase 2
4 gene 14.929807 14.953031 positive MGI_C57BL6J_3702175 Gm11837 NCBI_Gene:100038514,ENSEMBL:ENSMUSG00000086587 MGI:3702175 lncRNA gene predicted gene 11837
4 gene 14.952245 15.149804 negative MGI_C57BL6J_1916602 Necab1 NCBI_Gene:69352,ENSEMBL:ENSMUSG00000040536 MGI:1916602 protein coding gene N-terminal EF-hand calcium binding protein 1
4 gene 15.020715 15.032594 positive MGI_C57BL6J_3651040 Gm11844 NCBI_Gene:102640902,ENSEMBL:ENSMUSG00000087241 MGI:3651040 lncRNA gene predicted gene 11844
4 gene 15.090169 15.126648 positive MGI_C57BL6J_5595960 Gm36801 NCBI_Gene:102640824 MGI:5595960 lncRNA gene predicted gene, 36801
4 pseudogene 15.154392 15.154718 positive MGI_C57BL6J_3651557 Gm11845 ENSEMBL:ENSMUSG00000083073 MGI:3651557 pseudogene predicted gene 11845
4 gene 15.265820 15.286753 positive MGI_C57BL6J_2140359 Tmem64 NCBI_Gene:100201,ENSEMBL:ENSMUSG00000043252 MGI:2140359 protein coding gene transmembrane protein 64
4 gene 15.289097 15.327768 positive MGI_C57BL6J_5589042 Gm29883 NCBI_Gene:102631581 MGI:5589042 lncRNA gene predicted gene, 29883
4 gene 15.309147 15.317491 negative MGI_C57BL6J_5588988 Gm29829 NCBI_Gene:102631507 MGI:5588988 lncRNA gene predicted gene, 29829
4 gene 15.383148 15.383254 positive MGI_C57BL6J_5454094 Gm24317 ENSEMBL:ENSMUSG00000096738 MGI:5454094 snRNA gene predicted gene, 24317
4 pseudogene 15.486366 15.486790 positive MGI_C57BL6J_3649310 Gm11856 ENSEMBL:ENSMUSG00000080869 MGI:3649310 pseudogene predicted gene 11856
4 gene 15.522090 15.522126 positive MGI_C57BL6J_1925129 6030446M11Rik NA NA unclassified gene RIKEN cDNA 6030446M11 gene
4 pseudogene 15.531657 15.532111 negative MGI_C57BL6J_3649987 Gm11859 ENSEMBL:ENSMUSG00000083330 MGI:3649987 pseudogene predicted gene 11859
4 pseudogene 15.636169 15.636492 positive MGI_C57BL6J_3649311 Gm11857 NCBI_Gene:100503737,ENSEMBL:ENSMUSG00000082673 MGI:3649311 pseudogene predicted gene 11857
4 pseudogene 15.740930 15.741767 negative MGI_C57BL6J_3649986 Gm11858 ENSEMBL:ENSMUSG00000084181 MGI:3649986 pseudogene predicted gene 11858
4 pseudogene 15.819062 15.821373 negative MGI_C57BL6J_3649313 Gm11855 NCBI_Gene:633695,ENSEMBL:ENSMUSG00000081026 MGI:3649313 pseudogene predicted gene 11855
4 gene 15.819909 15.820029 positive MGI_C57BL6J_5454344 Gm24567 ENSEMBL:ENSMUSG00000094515 MGI:5454344 miRNA gene predicted gene, 24567
4 gene 15.881264 15.908064 positive MGI_C57BL6J_88248 Calb1 NCBI_Gene:12307,ENSEMBL:ENSMUSG00000028222 MGI:88248 protein coding gene calbindin 1
4 gene 15.911567 15.911634 negative MGI_C57BL6J_5455925 Gm26148 ENSEMBL:ENSMUSG00000088055 MGI:5455925 snoRNA gene predicted gene, 26148
4 gene 15.917240 15.945507 negative MGI_C57BL6J_1914710 Decr1 NCBI_Gene:67460,ENSEMBL:ENSMUSG00000028223 MGI:1914710 protein coding gene 2,4-dienoyl CoA reductase 1, mitochondrial
4 gene 15.942900 15.942991 negative MGI_C57BL6J_5530807 Mir6400 miRBase:MI0021936,NCBI_Gene:102466644,ENSEMBL:ENSMUSG00000098929 MGI:5530807 miRNA gene microRNA 6400
4 gene 15.956980 15.958208 negative MGI_C57BL6J_3697814 G830015F12Rik NA NA unclassified gene RIKEN cDNA G830015F12 gene
4 gene 15.957586 15.992589 positive MGI_C57BL6J_1351625 Nbn NCBI_Gene:27354,ENSEMBL:ENSMUSG00000028224 MGI:1351625 protein coding gene nibrin
4 pseudogene 15.969572 15.969928 negative MGI_C57BL6J_3650284 Gm11869 ENSEMBL:ENSMUSG00000084190 MGI:3650284 pseudogene predicted gene 11869
4 gene 15.997121 16.014660 negative MGI_C57BL6J_2384798 Osgin2 NCBI_Gene:209212,ENSEMBL:ENSMUSG00000041153 MGI:2384798 protein coding gene oxidative stress induced growth inhibitor family member 2
4 pseudogene 16.011005 16.012326 negative MGI_C57BL6J_3650285 Gm11870 ENSEMBL:ENSMUSG00000084408 MGI:3650285 pseudogene predicted gene 11870
4 pseudogene 16.120759 16.120888 negative MGI_C57BL6J_3649335 Gm11874 ENSEMBL:ENSMUSG00000081679 MGI:3649335 pseudogene predicted gene 11874
4 gene 16.122733 16.163676 negative MGI_C57BL6J_1891456 Ripk2 NCBI_Gene:192656,ENSEMBL:ENSMUSG00000041135 MGI:1891456 protein coding gene receptor (TNFRSF)-interacting serine-threonine kinase 2
4 gene 16.129566 16.129675 negative MGI_C57BL6J_5452467 Gm22690 ENSEMBL:ENSMUSG00000092795 MGI:5452467 miRNA gene predicted gene, 22690
4 gene 16.164109 16.165509 positive MGI_C57BL6J_2443826 A730041O05Rik NA NA unclassified gene RIKEN cDNA A730041O05 gene
4 gene 16.164110 16.266225 positive MGI_C57BL6J_4440477 A530072M11Rik NCBI_Gene:100415915,ENSEMBL:ENSMUSG00000085112 MGI:4440477 lncRNA gene RIKEN cDNA gene A530072M11
4 pseudogene 16.246060 16.250256 positive MGI_C57BL6J_3650453 Gm11865 NCBI_Gene:667150,ENSEMBL:ENSMUSG00000083725 MGI:3650453 pseudogene predicted gene 11865
4 gene 16.384052 16.384657 positive MGI_C57BL6J_5610583 Gm37355 ENSEMBL:ENSMUSG00000103595 MGI:5610583 unclassified gene predicted gene, 37355
4 pseudogene 16.390445 16.391664 negative MGI_C57BL6J_3650454 Gm11864 NCBI_Gene:383994,ENSEMBL:ENSMUSG00000080065 MGI:3650454 pseudogene predicted gene 11864
4 gene 16.464876 16.509323 positive MGI_C57BL6J_3650457 Gm11861 ENSEMBL:ENSMUSG00000086072 MGI:3650457 lncRNA gene predicted gene 11861
4 gene 16.675923 16.676029 positive MGI_C57BL6J_5454755 Gm24978 ENSEMBL:ENSMUSG00000096423 MGI:5454755 snRNA gene predicted gene, 24978
4 pseudogene 16.714944 16.715620 positive MGI_C57BL6J_3650456 Gm11862 NCBI_Gene:100416555,ENSEMBL:ENSMUSG00000083229 MGI:3650456 pseudogene predicted gene 11862
4 gene 16.861689 16.861794 negative MGI_C57BL6J_5453752 Gm23975 ENSEMBL:ENSMUSG00000064619 MGI:5453752 snRNA gene predicted gene, 23975
4 pseudogene 17.032688 17.033660 negative MGI_C57BL6J_3652231 Gm11848 NCBI_Gene:667212,ENSEMBL:ENSMUSG00000082994 MGI:3652231 pseudogene predicted gene 11848
4 pseudogene 17.045574 17.046052 negative MGI_C57BL6J_3652013 Gm11850 ENSEMBL:ENSMUSG00000082552 MGI:3652013 pseudogene predicted gene 11850
4 pseudogene 17.256101 17.256361 negative MGI_C57BL6J_3652012 Gm11849 ENSEMBL:ENSMUSG00000083572 MGI:3652012 pseudogene predicted gene 11849
4 gene 17.487627 17.514003 negative MGI_C57BL6J_5625142 Gm42257 NCBI_Gene:105247098 MGI:5625142 lncRNA gene predicted gene, 42257
4 gene 17.546456 17.636247 negative MGI_C57BL6J_5589251 Gm30092 NCBI_Gene:102631866 MGI:5589251 lncRNA gene predicted gene, 30092
4 gene 17.559917 17.560019 negative MGI_C57BL6J_5453161 Gm23384 ENSEMBL:ENSMUSG00000089218 MGI:5453161 snRNA gene predicted gene, 23384
4 gene 17.656675 17.657963 negative MGI_C57BL6J_3652014 Gm11851 ENSEMBL:ENSMUSG00000085478 MGI:3652014 lncRNA gene predicted gene 11851
4 gene 17.852893 18.123739 positive MGI_C57BL6J_1276107 Mmp16 NCBI_Gene:17389,ENSEMBL:ENSMUSG00000028226 MGI:1276107 protein coding gene matrix metallopeptidase 16
4 pseudogene 18.009218 18.010245 negative MGI_C57BL6J_3649715 Gm11860 NCBI_Gene:100417900,ENSEMBL:ENSMUSG00000083387 MGI:3649715 pseudogene predicted gene 11860
4 pseudogene 18.193531 18.193752 positive MGI_C57BL6J_3649491 Gm11852 ENSEMBL:ENSMUSG00000083150 MGI:3649491 pseudogene predicted gene 11852
4 gene 18.407349 18.891842 positive MGI_C57BL6J_3650506 Gm11867 ENSEMBL:ENSMUSG00000087402 MGI:3650506 lncRNA gene predicted gene 11867
4 pseudogene 18.471669 18.472114 negative MGI_C57BL6J_3651402 Gm11854 ENSEMBL:ENSMUSG00000080919 MGI:3651402 pseudogene predicted gene 11854
4 pseudogene 18.472189 18.481668 positive MGI_C57BL6J_3649490 Gm11853 NCBI_Gene:100416840,ENSEMBL:ENSMUSG00000083660 MGI:3649490 pseudogene predicted gene 11853
4 gene 18.708748 18.709033 positive MGI_C57BL6J_5455748 Gm25971 ENSEMBL:ENSMUSG00000089578 MGI:5455748 unclassified non-coding RNA gene predicted gene, 25971
4 gene 18.730217 18.730548 negative MGI_C57BL6J_5454196 Gm24419 ENSEMBL:ENSMUSG00000088500 MGI:5454196 unclassified non-coding RNA gene predicted gene, 24419
4 gene 18.767985 19.122526 negative MGI_C57BL6J_3650508 Cnbd1 NCBI_Gene:435772,ENSEMBL:ENSMUSG00000073991 MGI:3650508 protein coding gene cyclic nucleotide binding domain containing 1
4 pseudogene 18.844202 18.845679 negative MGI_C57BL6J_3650507 Gm11868 NCBI_Gene:667251,ENSEMBL:ENSMUSG00000050550 MGI:3650507 pseudogene predicted gene 11868
4 pseudogene 18.964564 18.965501 positive MGI_C57BL6J_3651008 Gm12392 ENSEMBL:ENSMUSG00000083005 MGI:3651008 pseudogene predicted gene 12392
4 gene 19.122636 19.137732 positive MGI_C57BL6J_5625143 Gm42258 NCBI_Gene:105247099 MGI:5625143 lncRNA gene predicted gene, 42258
4 pseudogene 19.259090 19.259943 positive MGI_C57BL6J_3651009 Gm12393 NCBI_Gene:100417903,ENSEMBL:ENSMUSG00000083105 MGI:3651009 pseudogene predicted gene 12393
4 gene 19.280850 19.510623 positive MGI_C57BL6J_1353562 Cngb3 NCBI_Gene:30952,ENSEMBL:ENSMUSG00000056494 MGI:1353562 protein coding gene cyclic nucleotide gated channel beta 3
4 pseudogene 19.298257 19.299184 positive MGI_C57BL6J_3652029 Gm11877 NCBI_Gene:623122,ENSEMBL:ENSMUSG00000082320 MGI:3652029 pseudogene predicted gene 11877
4 gene 19.514490 19.514779 negative MGI_C57BL6J_5455432 Gm25655 ENSEMBL:ENSMUSG00000089090 MGI:5455432 unclassified non-coding RNA gene predicted gene, 25655
4 gene 19.519248 19.570108 negative MGI_C57BL6J_1917818 Cpne3 NCBI_Gene:70568,ENSEMBL:ENSMUSG00000028228 MGI:1917818 protein coding gene copine III
4 gene 19.573112 19.606932 positive MGI_C57BL6J_1913552 Rmdn1 NCBI_Gene:66302,ENSEMBL:ENSMUSG00000028229 MGI:1913552 protein coding gene regulator of microtubule dynamics 1
4 gene 19.605451 19.651130 positive MGI_C57BL6J_3699710 Gm12353 ENSEMBL:ENSMUSG00000078772 MGI:3699710 protein coding gene predicted gene 12353
4 gene 19.608296 19.709006 negative MGI_C57BL6J_1861728 Wwp1 NCBI_Gene:107568,ENSEMBL:ENSMUSG00000041058 MGI:1861728 protein coding gene WW domain containing E3 ubiquitin protein ligase 1
4 gene 19.612906 19.618278 negative MGI_C57BL6J_5625144 Gm42259 NCBI_Gene:105247100 MGI:5625144 lncRNA gene predicted gene, 42259
4 gene 19.716576 19.720805 negative MGI_C57BL6J_3649534 Gm12354 NCBI_Gene:102632246,ENSEMBL:ENSMUSG00000086071 MGI:3649534 lncRNA gene predicted gene 12354
4 gene 19.818725 19.842218 positive MGI_C57BL6J_1921337 Slc7a13 NCBI_Gene:74087,ENSEMBL:ENSMUSG00000041052 MGI:1921337 protein coding gene solute carrier family 7, (cationic amino acid transporter, y+ system) member 13
4 gene 19.876838 19.922605 negative MGI_C57BL6J_1924415 Atp6v0d2 NCBI_Gene:242341,ENSEMBL:ENSMUSG00000028238 MGI:1924415 protein coding gene ATPase, H+ transporting, lysosomal V0 subunit D2
4 gene 19.902928 19.903930 negative MGI_C57BL6J_1921005 4833419A21Rik NA NA unclassified gene RIKEN cDNA 4833419A21 gene
4 gene 19.979445 20.005739 negative MGI_C57BL6J_1922238 4930480G23Rik NCBI_Gene:74988,ENSEMBL:ENSMUSG00000086332 MGI:1922238 lncRNA gene RIKEN cDNA 4930480G23 gene
4 gene 20.007909 20.030822 positive MGI_C57BL6J_1354168 Ttpa NCBI_Gene:50500,ENSEMBL:ENSMUSG00000073988 MGI:1354168 protein coding gene tocopherol (alpha) transfer protein
4 gene 20.032787 20.041924 negative MGI_C57BL6J_2152336 4930598A11Rik NCBI_Gene:105247101,ENSEMBL:ENSMUSG00000097005 MGI:2152336 lncRNA gene RIKEN cDNA 4930598A11 gene
4 gene 20.041987 20.066750 positive MGI_C57BL6J_1329035 Ggh NCBI_Gene:14590,ENSEMBL:ENSMUSG00000073987 MGI:1329035 protein coding gene gamma-glutamyl hydrolase
4 pseudogene 20.073320 20.073790 positive MGI_C57BL6J_5588973 Gm29814 NCBI_Gene:102216271 MGI:5588973 pseudogene predicted gene, 29814
4 gene 20.111029 20.780309 negative MGI_C57BL6J_2444830 Nkain3 NCBI_Gene:269513,ENSEMBL:ENSMUSG00000055761 MGI:2444830 protein coding gene Na+/K+ transporting ATPase interacting 3
4 gene 20.343706 20.347818 positive MGI_C57BL6J_3649333 Gm11872 ENSEMBL:ENSMUSG00000086017 MGI:3649333 lncRNA gene predicted gene 11872
4 pseudogene 20.391038 20.392469 positive MGI_C57BL6J_3649334 Gm11873 NCBI_Gene:100416132,ENSEMBL:ENSMUSG00000081964 MGI:3649334 pseudogene predicted gene 11873
4 pseudogene 21.009880 21.010940 negative MGI_C57BL6J_3649332 Gm11871 NCBI_Gene:100418457,ENSEMBL:ENSMUSG00000083315 MGI:3649332 pseudogene predicted gene 11871
4 gene 21.270075 21.270430 positive MGI_C57BL6J_5452594 Gm22817 ENSEMBL:ENSMUSG00000088073 MGI:5452594 ribozyme gene predicted gene, 22817
4 gene 21.328520 21.328604 positive MGI_C57BL6J_5455754 Gm25977 ENSEMBL:ENSMUSG00000089322 MGI:5455754 snoRNA gene predicted gene, 25977
4 pseudogene 21.626380 21.627184 positive MGI_C57BL6J_3649519 Gm11875 NCBI_Gene:100418304,ENSEMBL:ENSMUSG00000083654 MGI:3649519 pseudogene predicted gene 11875
4 pseudogene 21.671040 21.671308 positive MGI_C57BL6J_3649518 Gm11876 ENSEMBL:ENSMUSG00000082672 MGI:3649518 pseudogene predicted gene 11876
4 gene 21.675865 21.685963 negative MGI_C57BL6J_2448528 Prdm13 NCBI_Gene:230025,ENSEMBL:ENSMUSG00000040478 MGI:2448528 protein coding gene PR domain containing 13
4 gene 21.727701 21.759922 positive MGI_C57BL6J_1858199 Ccnc NCBI_Gene:51813,ENSEMBL:ENSMUSG00000028252 MGI:1858199 protein coding gene cyclin C
4 gene 21.757382 21.767212 negative MGI_C57BL6J_1924282 Tstd3 NCBI_Gene:77032,ENSEMBL:ENSMUSG00000028251 MGI:1924282 protein coding gene thiosulfate sulfurtransferase (rhodanese)-like domain containing 3
4 gene 21.767156 21.837872 positive MGI_C57BL6J_101850 Usp45 NCBI_Gene:77593,ENSEMBL:ENSMUSG00000040455 MGI:101850 protein coding gene ubiquitin specific petidase 45
4 gene 21.846327 21.848448 negative MGI_C57BL6J_1914985 4930528A17Rik NCBI_Gene:67735 MGI:1914985 lncRNA gene RIKEN cDNA 4930528A17 gene
4 gene 21.847583 21.876475 positive MGI_C57BL6J_1913875 Pnisr NCBI_Gene:66625,ENSEMBL:ENSMUSG00000028248 MGI:1913875 protein coding gene PNN interacting serine/arginine-rich
4 gene 21.879673 21.912163 positive MGI_C57BL6J_101813 Coq3 NCBI_Gene:230027,ENSEMBL:ENSMUSG00000028247 MGI:101813 protein coding gene coenzyme Q3 methyltransferase
4 gene 21.930000 22.001461 positive MGI_C57BL6J_1923382 Faxc NCBI_Gene:76132,ENSEMBL:ENSMUSG00000028246 MGI:1923382 protein coding gene failed axon connections homolog
4 pseudogene 22.006762 22.008189 negative MGI_C57BL6J_3649645 Gm11885 NCBI_Gene:100416924,ENSEMBL:ENSMUSG00000080997 MGI:3649645 pseudogene predicted gene 11885
4 gene 22.024034 22.040372 positive MGI_C57BL6J_5625145 Gm42260 NCBI_Gene:105247102 MGI:5625145 lncRNA gene predicted gene, 42260
4 pseudogene 22.117134 22.117532 negative MGI_C57BL6J_3651782 Gm11880 ENSEMBL:ENSMUSG00000082490 MGI:3651782 pseudogene predicted gene 11880
4 gene 22.248631 22.357437 negative MGI_C57BL6J_5625146 Gm42261 NCBI_Gene:105247103 MGI:5625146 lncRNA gene predicted gene, 42261
4 pseudogene 22.275833 22.276338 positive MGI_C57BL6J_3651786 Gm11882 ENSEMBL:ENSMUSG00000083376 MGI:3651786 pseudogene predicted gene 11882
4 gene 22.357543 22.434091 positive MGI_C57BL6J_2140367 Fbxl4 NCBI_Gene:269514,ENSEMBL:ENSMUSG00000040410 MGI:2140367 protein coding gene F-box and leucine-rich repeat protein 4
4 gene 22.396570 22.396702 positive MGI_C57BL6J_5454384 Gm24607 ENSEMBL:ENSMUSG00000077561 MGI:5454384 snoRNA gene predicted gene, 24607
4 gene 22.408291 22.412095 positive MGI_C57BL6J_5611128 Gm37900 ENSEMBL:ENSMUSG00000103000 MGI:5611128 unclassified gene predicted gene, 37900
4 gene 22.482095 22.488366 negative MGI_C57BL6J_101895 Pou3f2 NCBI_Gene:18992,ENSEMBL:ENSMUSG00000095139 MGI:101895 protein coding gene POU domain, class 3, transcription factor 2
4 gene 22.490548 22.493126 positive MGI_C57BL6J_5589890 Gm30731 NCBI_Gene:105500046,ENSEMBL:ENSMUSG00000107859 MGI:5589890 lncRNA gene predicted gene, 30731
4 pseudogene 22.519613 22.520097 positive MGI_C57BL6J_3651784 Gm11878 NCBI_Gene:664911,ENSEMBL:ENSMUSG00000081810 MGI:3651784 pseudogene predicted gene 11878
4 pseudogene 22.528438 22.529009 negative MGI_C57BL6J_3652336 Gm11881 ENSEMBL:ENSMUSG00000083514 MGI:3652336 pseudogene predicted gene 11881
4 pseudogene 22.704057 22.704758 positive MGI_C57BL6J_3651783 Gm11879 ENSEMBL:ENSMUSG00000080762 MGI:3651783 pseudogene predicted gene 11879
4 gene 22.747131 22.747233 positive MGI_C57BL6J_5453855 Gm24078 ENSEMBL:ENSMUSG00000088809 MGI:5453855 miRNA gene predicted gene, 24078
4 gene 22.771853 22.836256 negative MGI_C57BL6J_5625147 Gm42262 NCBI_Gene:105247104 MGI:5625147 lncRNA gene predicted gene, 42262
4 gene 22.928167 22.938435 negative MGI_C57BL6J_1917234 1700025O08Rik ENSEMBL:ENSMUSG00000028244 MGI:1917234 lncRNA gene RIKEN cDNA 1700025O08 gene
4 gene 22.938575 22.979509 positive MGI_C57BL6J_5590045 Gm30886 NCBI_Gene:102632939 MGI:5590045 lncRNA gene predicted gene, 30886
4 gene 23.260784 23.311024 positive MGI_C57BL6J_5621335 Gm38450 NCBI_Gene:102633008 MGI:5621335 lncRNA gene predicted gene, 38450
4 gene 23.260784 23.397837 positive MGI_C57BL6J_3651157 Gm11884 NCBI_Gene:102633109,ENSEMBL:ENSMUSG00000087098 MGI:3651157 lncRNA gene predicted gene 11884
4 gene 23.468948 23.514565 negative MGI_C57BL6J_5590244 Gm31085 NCBI_Gene:102633197 MGI:5590244 lncRNA gene predicted gene, 31085
4 pseudogene 23.484820 23.486020 positive MGI_C57BL6J_3651111 Gm11888 NCBI_Gene:625462,ENSEMBL:ENSMUSG00000083785 MGI:3651111 pseudogene predicted gene 11888
4 pseudogene 23.516703 23.519485 negative MGI_C57BL6J_3651112 Gm11889 NCBI_Gene:383998,ENSEMBL:ENSMUSG00000082876 MGI:3651112 pseudogene predicted gene 11889
4 gene 23.626656 23.626745 negative MGI_C57BL6J_5455755 Gm25978 ENSEMBL:ENSMUSG00000089323 MGI:5455755 miRNA gene predicted gene, 25978
4 pseudogene 23.659928 23.660344 negative MGI_C57BL6J_3651113 Gm11890 ENSEMBL:ENSMUSG00000084179 MGI:3651113 pseudogene predicted gene 11890
4 gene 23.689815 23.835052 negative MGI_C57BL6J_5590304 Gm31145 NCBI_Gene:102633283 MGI:5590304 lncRNA gene predicted gene, 31145
4 gene 23.933488 23.933954 negative MGI_C57BL6J_5579154 Gm28448 ENSEMBL:ENSMUSG00000100395 MGI:5579154 lncRNA gene predicted gene 28448
4 gene 23.976543 24.430909 negative MGI_C57BL6J_5521086 Gm27243 NCBI_Gene:102633477,ENSEMBL:ENSMUSG00000099150 MGI:5521086 lncRNA gene predicted gene 27243
4 pseudogene 24.238088 24.239301 positive MGI_C57BL6J_3651298 Gm11892 NCBI_Gene:664973,ENSEMBL:ENSMUSG00000083154 MGI:3651298 pseudogene predicted gene 11892
4 pseudogene 24.423477 24.425192 positive MGI_C57BL6J_3651088 Gm11891 ENSEMBL:ENSMUSG00000081148 MGI:3651088 pseudogene predicted gene 11891
4 gene 24.496224 24.602950 positive MGI_C57BL6J_2684980 Mms22l NCBI_Gene:212377,ENSEMBL:ENSMUSG00000045751 MGI:2684980 protein coding gene MMS22-like, DNA repair protein
4 gene 24.612554 24.851124 negative MGI_C57BL6J_3612790 Klhl32 NCBI_Gene:212390,ENSEMBL:ENSMUSG00000040387 MGI:3612790 protein coding gene kelch-like 32
4 gene 24.668331 24.674095 positive MGI_C57BL6J_5590595 Gm31436 NCBI_Gene:102633665 MGI:5590595 lncRNA gene predicted gene, 31436
4 gene 24.792680 24.800310 positive MGI_C57BL6J_3649624 Gm11899 ENSEMBL:ENSMUSG00000087399 MGI:3649624 lncRNA gene predicted gene 11899
4 gene 24.851260 24.879267 positive MGI_C57BL6J_5590538 Gm31379 NCBI_Gene:102633591 MGI:5590538 lncRNA gene predicted gene, 31379
4 gene 24.881176 24.897950 negative MGI_C57BL6J_5826485 Gm46848 NCBI_Gene:108168934 MGI:5826485 lncRNA gene predicted gene, 46848
4 gene 24.894880 24.897975 negative MGI_C57BL6J_1921668 4932702M13Rik NA NA unclassified gene RIKEN cDNA 4932702M13 gene
4 gene 24.898083 24.905001 positive MGI_C57BL6J_1915743 Ndufaf4 NCBI_Gene:68493,ENSEMBL:ENSMUSG00000028261 MGI:1915743 protein coding gene NADH:ubiquinone oxidoreductase complex assembly factor 4
4 gene 24.960790 24.972029 negative MGI_C57BL6J_2442283 C230012O17Rik NCBI_Gene:319564,ENSEMBL:ENSMUSG00000046219 MGI:2442283 lncRNA gene RIKEN cDNA C230012O17 gene
4 gene 24.966407 25.009233 positive MGI_C57BL6J_2135884 Gpr63 NCBI_Gene:81006,ENSEMBL:ENSMUSG00000040372 MGI:2135884 protein coding gene G protein-coupled receptor 63
4 gene 24.966517 25.271099 positive MGI_C57BL6J_3705114 Gm11906 ENSEMBL:ENSMUSG00000085885 MGI:3705114 lncRNA gene predicted gene 11906
4 gene 25.010052 25.012720 positive MGI_C57BL6J_2442673 9330118A15Rik NA NA unclassified gene RIKEN cDNA 9330118A15 gene
4 gene 25.199907 25.243046 negative MGI_C57BL6J_1913192 Fhl5 NCBI_Gene:57756,ENSEMBL:ENSMUSG00000028259 MGI:1913192 protein coding gene four and a half LIM domains 5
4 gene 25.247820 25.281930 negative MGI_C57BL6J_1914740 Ufl1 NCBI_Gene:67490,ENSEMBL:ENSMUSG00000040359 MGI:1914740 protein coding gene UFM1 specific ligase 1
4 pseudogene 25.307777 25.309139 positive MGI_C57BL6J_1203519 Prdx6-ps2 NCBI_Gene:384001,ENSEMBL:ENSMUSG00000083737 MGI:1203519 pseudogene peroxiredoxin 6 pseudogene 2
4 pseudogene 25.353702 25.354538 negative MGI_C57BL6J_3651206 Gm11897 NCBI_Gene:665019,ENSEMBL:ENSMUSG00000081786 MGI:3651206 pseudogene predicted gene 11897
4 pseudogene 25.419349 25.419676 positive MGI_C57BL6J_3651417 Gm11894 ENSEMBL:ENSMUSG00000082451 MGI:3651417 pseudogene predicted gene 11894
4 gene 25.513451 25.513575 negative MGI_C57BL6J_5455752 Gm25975 ENSEMBL:ENSMUSG00000089327 MGI:5455752 snoRNA gene predicted gene, 25975
4 pseudogene 25.538850 25.539669 positive MGI_C57BL6J_3651205 Gm11896 NCBI_Gene:100418387,ENSEMBL:ENSMUSG00000081369 MGI:3651205 pseudogene predicted gene 11896
4 pseudogene 25.541663 25.542546 negative MGI_C57BL6J_3651418 Gm11893 NCBI_Gene:625732,ENSEMBL:ENSMUSG00000081789 MGI:3651418 pseudogene predicted gene 11893
4 gene 25.566660 25.566822 negative MGI_C57BL6J_5454754 Gm24977 ENSEMBL:ENSMUSG00000065040 MGI:5454754 snRNA gene predicted gene, 24977
4 gene 25.609332 25.800244 negative MGI_C57BL6J_1330859 Fut9 NCBI_Gene:14348,ENSEMBL:ENSMUSG00000055373 MGI:1330859 protein coding gene fucosyltransferase 9
4 gene 25.819671 25.819773 negative MGI_C57BL6J_5453819 Gm24042 ENSEMBL:ENSMUSG00000065048 MGI:5453819 snRNA gene predicted gene, 24042
4 gene 25.845158 25.853414 negative MGI_C57BL6J_5625148 Gm42263 NCBI_Gene:105247105 MGI:5625148 lncRNA gene predicted gene, 42263
4 pseudogene 25.854515 25.854899 negative MGI_C57BL6J_3651207 Gm11898 ENSEMBL:ENSMUSG00000083835 MGI:3651207 pseudogene predicted gene 11898
4 gene 25.861239 25.861348 negative MGI_C57BL6J_5455844 Gm26067 ENSEMBL:ENSMUSG00000076977 MGI:5455844 miRNA gene predicted gene, 26067
4 pseudogene 25.866275 25.868550 negative MGI_C57BL6J_3651868 Gm11895 NCBI_Gene:546829,ENSEMBL:ENSMUSG00000084018 MGI:3651868 pseudogene predicted gene 11895
4 gene 25.940365 25.940470 positive MGI_C57BL6J_5454742 Gm24965 ENSEMBL:ENSMUSG00000088547 MGI:5454742 snRNA gene predicted gene, 24965
4 gene 26.324506 26.346891 negative MGI_C57BL6J_2444484 Manea NCBI_Gene:242362,ENSEMBL:ENSMUSG00000040520 MGI:2444484 protein coding gene mannosidase, endo-alpha
4 pseudogene 26.368404 26.370275 negative MGI_C57BL6J_1888909 Bhmt-ps1 NCBI_Gene:57421,ENSEMBL:ENSMUSG00000096105 MGI:1888909 pseudogene betaine-homocysteine methyltransferase, pseudogene 1
4 pseudogene 26.442461 26.443256 positive MGI_C57BL6J_3651055 Gm11903 NCBI_Gene:665079,ENSEMBL:ENSMUSG00000082573 MGI:3651055 pseudogene predicted gene 11903
4 pseudogene 26.501323 26.501736 negative MGI_C57BL6J_1336164 Gng2-ps1 NCBI_Gene:14703,ENSEMBL:ENSMUSG00000081985 MGI:1336164 pseudogene guanine nucleotide binding protein (G protein), gamma 2 subunit, pseudogene 1
4 pseudogene 26.593490 26.594167 negative MGI_C57BL6J_3650369 Gm11905 NCBI_Gene:100416085,ENSEMBL:ENSMUSG00000082138 MGI:3650369 pseudogene predicted gene 11905
4 gene 26.635820 26.705449 negative MGI_C57BL6J_1922610 4930548K13Rik NCBI_Gene:75360,ENSEMBL:ENSMUSG00000086257 MGI:1922610 lncRNA gene RIKEN cDNA 4930548K13 gene
4 gene 26.829835 26.858023 positive MGI_C57BL6J_5625149 Gm42264 NCBI_Gene:105247106 MGI:5625149 lncRNA gene predicted gene, 42264
4 pseudogene 27.126262 27.126509 negative MGI_C57BL6J_3650583 Gm11904 ENSEMBL:ENSMUSG00000083447 MGI:3650583 pseudogene predicted gene 11904
4 pseudogene 27.222135 27.222404 negative MGI_C57BL6J_3650593 Gm11902 ENSEMBL:ENSMUSG00000080958 MGI:3650593 pseudogene predicted gene 11902
4 pseudogene 27.543178 27.543614 positive MGI_C57BL6J_3651329 Gm11901 ENSEMBL:ENSMUSG00000084163 MGI:3651329 pseudogene predicted gene 11901
4 gene 27.700671 27.700777 positive MGI_C57BL6J_5454950 Gm25173 ENSEMBL:ENSMUSG00000095003 MGI:5454950 snRNA gene predicted gene, 25173
4 pseudogene 27.867140 27.867655 negative MGI_C57BL6J_3649889 Gm11914 NCBI_Gene:100040691,ENSEMBL:ENSMUSG00000082674 MGI:3649889 pseudogene predicted gene 11914
4 gene 27.904779 27.904852 positive MGI_C57BL6J_4413903 n-TIaat2 NCBI_Gene:102467541 MGI:4413903 tRNA gene nuclear encoded tRNA isoleucine 2 (anticodon AAT)
4 pseudogene 27.996004 27.996906 negative MGI_C57BL6J_99710 Tpm3-rs2 NCBI_Gene:625912,ENSEMBL:ENSMUSG00000080175 MGI:99710 pseudogene tropomyosin 3, related sequence 2
4 pseudogene 28.067177 28.068208 positive MGI_C57BL6J_3650144 Gm11911 NCBI_Gene:100417848,ENSEMBL:ENSMUSG00000082977 MGI:3650144 pseudogene predicted gene 11911
4 pseudogene 28.149988 28.150475 positive MGI_C57BL6J_5625198 Gm42313 NCBI_Gene:105247165 MGI:5625198 pseudogene predicted gene, 42313
4 pseudogene 28.353762 28.354998 positive MGI_C57BL6J_3650140 Gm11907 NCBI_Gene:230044,ENSEMBL:ENSMUSG00000082703 MGI:3650140 pseudogene predicted gene 11907
4 gene 28.365316 28.365444 positive MGI_C57BL6J_5455155 Gm25378 ENSEMBL:ENSMUSG00000077521 MGI:5455155 snoRNA gene predicted gene, 25378
4 pseudogene 28.486112 28.486484 negative MGI_C57BL6J_3650143 Gm11908 NCBI_Gene:665141,ENSEMBL:ENSMUSG00000082359 MGI:3650143 pseudogene predicted gene 11908
4 pseudogene 28.559939 28.560715 negative MGI_C57BL6J_3650142 Gm11909 NCBI_Gene:100416252,ENSEMBL:ENSMUSG00000081579 MGI:3650142 pseudogene predicted gene 11909
4 pseudogene 28.591653 28.592571 negative MGI_C57BL6J_3651484 Gm11910 ENSEMBL:ENSMUSG00000084073 MGI:3651484 pseudogene predicted gene 11910
4 pseudogene 28.592576 28.592839 positive MGI_C57BL6J_3650147 Gm11912 ENSEMBL:ENSMUSG00000083214 MGI:3650147 pseudogene predicted gene 11912
4 pseudogene 28.612326 28.612742 positive MGI_C57BL6J_3650146 Gm11913 ENSEMBL:ENSMUSG00000081011 MGI:3650146 pseudogene predicted gene 11913
4 gene 28.813047 28.967511 positive MGI_C57BL6J_95276 Epha7 NCBI_Gene:13841,ENSEMBL:ENSMUSG00000028289 MGI:95276 protein coding gene Eph receptor A7
4 gene 28.814297 28.815076 negative MGI_C57BL6J_3650126 Gm11915 ENSEMBL:ENSMUSG00000086774 MGI:3650126 lncRNA gene predicted gene 11915
4 gene 28.836886 28.839678 positive MGI_C57BL6J_2442004 D930030K17Rik NA NA unclassified gene RIKEN cDNA D930030K17 gene
4 gene 28.926099 28.929038 positive MGI_C57BL6J_1919125 2300010F08Rik NA NA unclassified gene RIKEN cDNA 2300010F08 gene
4 gene 29.068079 29.088914 positive MGI_C57BL6J_3651770 Gm11917 NCBI_Gene:102634169,ENSEMBL:ENSMUSG00000087316 MGI:3651770 lncRNA gene predicted gene 11917
4 gene 29.090605 29.091662 positive MGI_C57BL6J_3650125 Gm11916 ENSEMBL:ENSMUSG00000086339 MGI:3650125 lncRNA gene predicted gene 11916
4 pseudogene 29.125946 29.126124 positive MGI_C57BL6J_3651436 Gm11918 ENSEMBL:ENSMUSG00000080911 MGI:3651436 pseudogene predicted gene 11918
4 pseudogene 29.195512 29.196278 positive MGI_C57BL6J_3650122 Gm11919 NCBI_Gene:100040811,ENSEMBL:ENSMUSG00000082486 MGI:3650122 pseudogene predicted gene 11919
4 pseudogene 29.490156 29.490663 positive MGI_C57BL6J_3652068 Gm11923 ENSEMBL:ENSMUSG00000082058 MGI:3652068 pseudogene predicted gene 11923
4 pseudogene 30.193647 30.194181 positive MGI_C57BL6J_3649864 Gm11925 ENSEMBL:ENSMUSG00000080771 MGI:3649864 pseudogene predicted gene 11925
4 gene 30.432112 30.523783 positive MGI_C57BL6J_3649863 Gm11924 ENSEMBL:ENSMUSG00000087180 MGI:3649863 lncRNA gene predicted gene 11924
4 gene 30.664596 30.855744 positive MGI_C57BL6J_1922582 4930556G01Rik NCBI_Gene:75332,ENSEMBL:ENSMUSG00000085522 MGI:1922582 lncRNA gene RIKEN cDNA 4930556G01 gene
4 gene 30.701949 30.702057 negative MGI_C57BL6J_5452608 Gm22831 ENSEMBL:ENSMUSG00000093947 MGI:5452608 miRNA gene predicted gene, 22831
4 pseudogene 30.701964 30.702606 negative MGI_C57BL6J_3650119 Gm11920 NCBI_Gene:619906,ENSEMBL:ENSMUSG00000082949 MGI:3650119 pseudogene predicted gene 11920
4 pseudogene 30.992680 30.996096 positive MGI_C57BL6J_5625199 Gm42314 NCBI_Gene:108168947 MGI:5625199 pseudogene predicted gene, 42314
4 gene 31.050066 31.418507 negative MGI_C57BL6J_5826486 Gm46849 NCBI_Gene:108168935 MGI:5826486 lncRNA gene predicted gene, 46849
4 gene 31.174909 31.175012 negative MGI_C57BL6J_5455482 Gm25705 ENSEMBL:ENSMUSG00000065053 MGI:5455482 snRNA gene predicted gene, 25705
4 gene 31.324093 31.332994 positive MGI_C57BL6J_5591332 Gm32173 NCBI_Gene:102634636 MGI:5591332 lncRNA gene predicted gene, 32173
4 pseudogene 31.380023 31.381520 positive MGI_C57BL6J_3650177 Gm11922 NCBI_Gene:100504194,ENSEMBL:ENSMUSG00000082254 MGI:3650177 pseudogene predicted gene 11922
4 gene 31.503062 31.512101 negative MGI_C57BL6J_5625200 Gm42315 NCBI_Gene:105247167 MGI:5625200 lncRNA gene predicted gene, 42315
4 gene 31.628477 31.628992 negative MGI_C57BL6J_5625150 Gm42265 NCBI_Gene:105247107 MGI:5625150 lncRNA gene predicted gene, 42265
4 gene 31.822055 31.831914 negative MGI_C57BL6J_5591571 Gm32412 NCBI_Gene:102634953 MGI:5591571 lncRNA gene predicted gene, 32412
4 gene 31.962569 31.963812 negative MGI_C57BL6J_1917570 2610008G14Rik NA NA unclassified gene RIKEN cDNA 2610008G14 gene
4 gene 31.963395 32.023470 positive MGI_C57BL6J_1346877 Map3k7 NCBI_Gene:26409,ENSEMBL:ENSMUSG00000028284 MGI:1346877 protein coding gene mitogen-activated protein kinase kinase kinase 7
4 pseudogene 31.990857 31.991286 negative MGI_C57BL6J_3651637 Gm11926 ENSEMBL:ENSMUSG00000084201 MGI:3651637 pseudogene predicted gene 11926
4 gene 31.998624 31.998741 negative MGI_C57BL6J_5456031 Gm26254 ENSEMBL:ENSMUSG00000084440 MGI:5456031 snRNA gene predicted gene, 26254
4 gene 32.007989 32.009136 positive MGI_C57BL6J_1924656 9530004M16Rik NA NA unclassified gene RIKEN cDNA 9530004M16 gene
4 pseudogene 32.051738 32.052989 positive MGI_C57BL6J_3651638 Gm11927 NCBI_Gene:665218,ENSEMBL:ENSMUSG00000082398 MGI:3651638 pseudogene predicted gene 11927
4 pseudogene 32.149786 32.150222 positive MGI_C57BL6J_3651635 Gm11928 ENSEMBL:ENSMUSG00000083872 MGI:3651635 pseudogene predicted gene 11928
4 gene 32.160976 32.186820 negative MGI_C57BL6J_5625151 Gm42266 NCBI_Gene:105247108 MGI:5625151 lncRNA gene predicted gene, 42266
4 pseudogene 32.207127 32.208225 positive MGI_C57BL6J_3651490 Gm11929 NCBI_Gene:665232,ENSEMBL:ENSMUSG00000083564 MGI:3651490 pseudogene predicted gene 11929
4 gene 32.230250 32.230320 positive MGI_C57BL6J_4413864 n-TGccc3 NCBI_Gene:102467527 MGI:4413864 tRNA gene nuclear encoded tRNA glycine 3 (anticodon CCC)
4 gene 32.238574 32.586109 positive MGI_C57BL6J_894679 Bach2 NCBI_Gene:12014,ENSEMBL:ENSMUSG00000040270 MGI:894679 protein coding gene BTB and CNC homology, basic leucine zipper transcription factor 2
4 gene 32.243733 32.246475 positive MGI_C57BL6J_3642664 D130062J21Rik NA NA unclassified gene RIKEN cDNA D130062J21 gene
4 gene 32.251761 32.265835 positive MGI_C57BL6J_3651084 Bach2it1 ENSEMBL:ENSMUSG00000087049 MGI:3651084 sense intronic lncRNA gene BTB and CNC homology 2, intronic transcript 1
4 gene 32.514787 32.515053 positive MGI_C57BL6J_5454148 Gm24371 ENSEMBL:ENSMUSG00000084611 MGI:5454148 unclassified non-coding RNA gene predicted gene, 24371
4 gene 32.559680 32.571708 negative MGI_C57BL6J_3041246 Bach2os NCBI_Gene:414068,ENSEMBL:ENSMUSG00000086150 MGI:3041246 antisense lncRNA gene BTB and CNC homology 2, opposite strand
4 gene 32.596960 32.602760 negative MGI_C57BL6J_1339969 Gja10 NCBI_Gene:14610,ENSEMBL:ENSMUSG00000051056 MGI:1339969 protein coding gene gap junction protein, alpha 10
4 pseudogene 32.611351 32.611725 positive MGI_C57BL6J_3649256 Gm11933 ENSEMBL:ENSMUSG00000081879 MGI:3649256 pseudogene predicted gene 11933
4 gene 32.615451 32.653271 positive MGI_C57BL6J_1349399 Casp8ap2 NCBI_Gene:26885,ENSEMBL:ENSMUSG00000028282 MGI:1349399 protein coding gene caspase 8 associated protein 2
4 gene 32.617500 32.620660 positive MGI_C57BL6J_2442802 A130074J08Rik NA NA unclassified gene RIKEN cDNA A130074J08 gene
4 pseudogene 32.655929 32.656088 negative MGI_C57BL6J_3650814 Gm11936 ENSEMBL:ENSMUSG00000081592 MGI:3650814 pseudogene predicted gene 11936
4 gene 32.657112 32.775217 positive MGI_C57BL6J_1926159 Mdn1 NCBI_Gene:100019,ENSEMBL:ENSMUSG00000058006 MGI:1926159 protein coding gene midasin AAA ATPase 1
4 gene 32.791267 32.792684 negative MGI_C57BL6J_5625152 Gm42267 NCBI_Gene:105247109 MGI:5625152 protein coding gene predicted gene, 42267
4 gene 32.800253 32.802268 positive MGI_C57BL6J_1917573 Lyrm2 NCBI_Gene:108755,ENSEMBL:ENSMUSG00000045854 MGI:1917573 protein coding gene LYR motif containing 2
4 gene 32.804027 32.950883 negative MGI_C57BL6J_2154278 Ankrd6 NCBI_Gene:140577,ENSEMBL:ENSMUSG00000040183 MGI:2154278 protein coding gene ankyrin repeat domain 6
4 pseudogene 32.892686 32.893295 positive MGI_C57BL6J_3650609 Gm11941 ENSEMBL:ENSMUSG00000083565 MGI:3650609 pseudogene predicted gene 11941
4 pseudogene 32.964806 32.965273 positive MGI_C57BL6J_3650608 Gm11942 NCBI_Gene:665298,ENSEMBL:ENSMUSG00000094344 MGI:3650608 pseudogene predicted gene 11942
4 gene 32.982998 33.022180 positive MGI_C57BL6J_1098604 Rragd NCBI_Gene:52187,ENSEMBL:ENSMUSG00000028278 MGI:1098604 protein coding gene Ras-related GTP binding D
4 pseudogene 33.001995 33.002321 negative MGI_C57BL6J_3650545 Gm11943 ENSEMBL:ENSMUSG00000081025 MGI:3650545 pseudogene predicted gene 11943
4 gene 33.027139 33.031323 negative MGI_C57BL6J_1918323 4933421O10Rik NCBI_Gene:100504166,ENSEMBL:ENSMUSG00000085037 MGI:1918323 lncRNA gene RIKEN cDNA 4933421O10 gene
4 gene 33.031387 33.052364 positive MGI_C57BL6J_1926245 Ube2j1 NCBI_Gene:56228,ENSEMBL:ENSMUSG00000028277 MGI:1926245 protein coding gene ubiquitin-conjugating enzyme E2J 1
4 pseudogene 33.053589 33.055751 negative MGI_C57BL6J_3652123 Gm11931 NCBI_Gene:100039142,ENSEMBL:ENSMUSG00000082851 MGI:3652123 pseudogene predicted gene 11931
4 gene 33.057712 33.095865 positive MGI_C57BL6J_95626 Gabrr2 NCBI_Gene:14409,ENSEMBL:ENSMUSG00000023267 MGI:95626 protein coding gene gamma-aminobutyric acid (GABA) C receptor, subunit rho 2
4 gene 33.132521 33.163588 positive MGI_C57BL6J_95625 Gabrr1 NCBI_Gene:14408,ENSEMBL:ENSMUSG00000028280 MGI:95625 protein coding gene gamma-aminobutyric acid (GABA) C receptor, subunit rho 1
4 gene 33.170401 33.189737 negative MGI_C57BL6J_2685270 Pm20d2 NCBI_Gene:242377,ENSEMBL:ENSMUSG00000054659 MGI:2685270 protein coding gene peptidase M20 domain containing 2
4 pseudogene 33.201764 33.202000 positive MGI_C57BL6J_3650032 Gm11930 NCBI_Gene:100504179,ENSEMBL:ENSMUSG00000083887 MGI:3650032 pseudogene predicted gene 11930
4 gene 33.208987 33.233344 positive MGI_C57BL6J_2661424 Srsf12 NCBI_Gene:272009,ENSEMBL:ENSMUSG00000054679 MGI:2661424 protein coding gene serine/arginine-rich splicing factor 12
4 gene 33.245423 33.290163 negative MGI_C57BL6J_1917838 Pnrc1 NCBI_Gene:108767,ENSEMBL:ENSMUSG00000040128 MGI:1917838 protein coding gene proline-rich nuclear receptor coactivator 1
4 gene 33.303569 33.310137 negative MGI_C57BL6J_3649212 Gm11934 ENSEMBL:ENSMUSG00000086127 MGI:3649212 lncRNA gene predicted gene 11934
4 gene 33.310299 33.502614 positive MGI_C57BL6J_1329041 Rngtt NCBI_Gene:24018,ENSEMBL:ENSMUSG00000028274 MGI:1329041 protein coding gene RNA guanylyltransferase and 5’-phosphatase
4 gene 33.402104 33.402708 positive MGI_C57BL6J_1925969 D530034E23Rik NA NA unclassified gene RIKEN cDNA D530034E23 gene
4 gene 33.438081 33.438209 positive MGI_C57BL6J_5531336 Mir8118 miRBase:MI0026050,NCBI_Gene:102465904,ENSEMBL:ENSMUSG00000098310 MGI:5531336 miRNA gene microRNA 8118
4 pseudogene 33.452491 33.452889 negative MGI_C57BL6J_3650811 Gm11935 ENSEMBL:ENSMUSG00000081206 MGI:3650811 pseudogene predicted gene 11935
4 gene 33.568248 33.577843 positive MGI_C57BL6J_5592052 Gm32893 NCBI_Gene:102635602 MGI:5592052 lncRNA gene predicted gene, 32893
4 gene 33.602866 33.629590 positive MGI_C57BL6J_5592114 Gm32955 NCBI_Gene:102635678 MGI:5592114 lncRNA gene predicted gene, 32955
4 gene 33.628841 33.628961 negative MGI_C57BL6J_5453081 Gm23304 ENSEMBL:ENSMUSG00000096184 MGI:5453081 miRNA gene predicted gene, 23304
4 gene 33.681367 33.681491 negative MGI_C57BL6J_5454118 Gm24341 ENSEMBL:ENSMUSG00000077397 MGI:5454118 snoRNA gene predicted gene, 24341
4 gene 33.780980 33.839079 positive MGI_C57BL6J_5592218 Gm33059 NCBI_Gene:102635813 MGI:5592218 lncRNA gene predicted gene, 33059
4 gene 33.798991 33.801048 positive MGI_C57BL6J_5592167 Gm33008 NCBI_Gene:102635748 MGI:5592167 lncRNA gene predicted gene, 33008
4 gene 33.893528 33.904368 negative MGI_C57BL6J_5592264 Gm33105 NCBI_Gene:102635881 MGI:5592264 lncRNA gene predicted gene, 33105
4 gene 33.923844 33.948831 positive MGI_C57BL6J_104615 Cnr1 NCBI_Gene:12801,ENSEMBL:ENSMUSG00000044288 MGI:104615 protein coding gene cannabinoid receptor 1 (brain)
4 gene 34.006306 34.006392 positive MGI_C57BL6J_5451787 Gm22010 ENSEMBL:ENSMUSG00000089414 MGI:5451787 snoRNA gene predicted gene, 22010
4 gene 34.024872 34.050191 negative MGI_C57BL6J_1914902 Spaca1 NCBI_Gene:67652,ENSEMBL:ENSMUSG00000028264 MGI:1914902 protein coding gene sperm acrosome associated 1
4 gene 34.086126 34.086233 positive MGI_C57BL6J_5455400 Gm25623 ENSEMBL:ENSMUSG00000087841 MGI:5455400 snRNA gene predicted gene, 25623
4 gene 34.130854 34.134800 positive MGI_C57BL6J_3652140 Gm12753 ENSEMBL:ENSMUSG00000087602 MGI:3652140 lncRNA gene predicted gene 12753
4 pseudogene 34.282127 34.282438 negative MGI_C57BL6J_5826492 Gm46855 NCBI_Gene:108168948 MGI:5826492 pseudogene predicted gene, 46855
4 gene 34.307828 34.316288 positive MGI_C57BL6J_5592445 Gm33286 NCBI_Gene:102636128 MGI:5592445 lncRNA gene predicted gene, 33286
4 gene 34.310975 34.319792 negative MGI_C57BL6J_5434120 Gm20764 NCBI_Gene:636187 MGI:5434120 protein coding gene predicted gene, 20764
4 pseudogene 34.353965 34.354854 positive MGI_C57BL6J_3651049 Gm12751 NCBI_Gene:100039220,ENSEMBL:ENSMUSG00000062554 MGI:3651049 pseudogene predicted gene 12751
4 gene 34.365894 34.371829 negative MGI_C57BL6J_5826519 Gm46882 NCBI_Gene:108168994 MGI:5826519 lncRNA gene predicted gene, 46882
4 pseudogene 34.379348 34.381081 negative MGI_C57BL6J_3650845 Gm12752 NCBI_Gene:100422784,ENSEMBL:ENSMUSG00000081384 MGI:3650845 pseudogene predicted gene 12752
4 pseudogene 34.389384 34.389871 negative MGI_C57BL6J_3651052 Gm12754 NCBI_Gene:100422785,ENSEMBL:ENSMUSG00000082649 MGI:3651052 pseudogene predicted gene 12754
4 gene 34.434296 34.434401 positive MGI_C57BL6J_5453243 Gm23466 ENSEMBL:ENSMUSG00000087758 MGI:5453243 unclassified non-coding RNA gene predicted gene, 23466
4 pseudogene 34.457861 34.458181 positive MGI_C57BL6J_3650346 Gm12351 NCBI_Gene:102636231,ENSEMBL:ENSMUSG00000084119 MGI:3650346 pseudogene predicted gene 12351
4 gene 34.482884 34.485591 negative MGI_C57BL6J_5592593 Gm33434 NCBI_Gene:102636341 MGI:5592593 lncRNA gene predicted gene, 33434
4 pseudogene 34.485723 34.486501 positive MGI_C57BL6J_3649478 Gm12350 NCBI_Gene:665367,ENSEMBL:ENSMUSG00000095588 MGI:3649478 pseudogene predicted gene 12350
4 gene 34.550615 34.566965 positive MGI_C57BL6J_1889364 Akirin2 NCBI_Gene:433693,ENSEMBL:ENSMUSG00000028291 MGI:1889364 protein coding gene akirin 2
4 gene 34.566781 34.614944 negative MGI_C57BL6J_1354944 Orc3 NCBI_Gene:50793,ENSEMBL:ENSMUSG00000040044 MGI:1354944 protein coding gene origin recognition complex, subunit 3
4 gene 34.614941 34.660167 positive MGI_C57BL6J_1923596 Rars2 NCBI_Gene:109093,ENSEMBL:ENSMUSG00000028292 MGI:1923596 protein coding gene arginyl-tRNA synthetase 2, mitochondrial
4 gene 34.663257 34.687838 negative MGI_C57BL6J_1345622 Slc35a1 NCBI_Gene:24060,ENSEMBL:ENSMUSG00000028293 MGI:1345622 protein coding gene solute carrier family 35 (CMP-sialic acid transporter), member 1
4 gene 34.683879 34.684185 positive MGI_C57BL6J_5452626 Gm22849 ENSEMBL:ENSMUSG00000088338 MGI:5452626 unclassified non-coding RNA gene predicted gene, 22849
4 gene 34.688559 34.730236 negative MGI_C57BL6J_1916579 Cfap206 NCBI_Gene:69329,ENSEMBL:ENSMUSG00000028294 MGI:1916579 protein coding gene cilia and flagella associated protein 206
4 gene 34.743784 34.756263 negative MGI_C57BL6J_2684982 Gm136 NCBI_Gene:214568,ENSEMBL:ENSMUSG00000071015 MGI:2684982 protein coding gene predicted gene 136
4 gene 34.768664 34.778423 negative MGI_C57BL6J_1913541 Smim8 NCBI_Gene:66291,ENSEMBL:ENSMUSG00000028295 MGI:1913541 protein coding gene small integral membrane protein 8
4 gene 34.803110 34.884936 negative MGI_C57BL6J_1353423 Zfp292 NCBI_Gene:30046,ENSEMBL:ENSMUSG00000039967 MGI:1353423 protein coding gene zinc finger protein 292
4 pseudogene 34.842985 34.843948 positive MGI_C57BL6J_3652293 Gm12363 NCBI_Gene:100416086,ENSEMBL:ENSMUSG00000082367 MGI:3652293 pseudogene predicted gene 12363
4 gene 34.855831 34.856429 positive MGI_C57BL6J_1919969 2810040C05Rik NA NA unclassified gene RIKEN cDNA 2810040C05 gene
4 gene 34.886712 34.889906 positive MGI_C57BL6J_4437737 A330027G23Rik NA NA unclassified gene RIKEN cDNA A330027G23 gene
4 gene 34.893779 34.907374 positive MGI_C57BL6J_88390 Cga NCBI_Gene:12640,ENSEMBL:ENSMUSG00000028298 MGI:88390 protein coding gene glycoprotein hormones, alpha subunit
4 gene 34.906124 34.911481 negative MGI_C57BL6J_1920946 Platr9 NCBI_Gene:73696,ENSEMBL:ENSMUSG00000085824 MGI:1920946 lncRNA gene pluripotency associated transcript 9
4 pseudogene 34.919129 34.920520 positive MGI_C57BL6J_3652291 Gm12361 NCBI_Gene:100418366,ENSEMBL:ENSMUSG00000083956 MGI:3652291 pseudogene predicted gene 12361
4 pseudogene 34.940766 34.941403 negative MGI_C57BL6J_3652292 Gm12362 NCBI_Gene:100504432,ENSEMBL:ENSMUSG00000082709 MGI:3652292 pseudogene predicted gene 12362
4 gene 34.949074 35.157493 negative MGI_C57BL6J_2664539 Mob3b NCBI_Gene:214944,ENSEMBL:ENSMUSG00000073910 MGI:2664539 protein coding gene MOB kinase activator 3B
4 gene 34.962220 34.966965 positive MGI_C57BL6J_3649785 Gm12364 ENSEMBL:ENSMUSG00000086792 MGI:3649785 lncRNA gene predicted gene 12364
4 gene 34.986545 35.001497 positive MGI_C57BL6J_5592779 Gm33620 NCBI_Gene:102636601 MGI:5592779 lncRNA gene predicted gene, 33620
4 gene 35.152055 35.154019 positive MGI_C57BL6J_2683287 Ifnk NCBI_Gene:387510,ENSEMBL:ENSMUSG00000042993 MGI:2683287 protein coding gene interferon kappa
4 gene 35.191282 35.226175 negative MGI_C57BL6J_1920455 C9orf72 NCBI_Gene:73205,ENSEMBL:ENSMUSG00000028300 MGI:1920455 protein coding gene C9orf72, member of C9orf72-SMCR8 complex
4 pseudogene 35.202061 35.203001 negative MGI_C57BL6J_3649557 Gm12366 NCBI_Gene:620559,ENSEMBL:ENSMUSG00000082762 MGI:3649557 pseudogene predicted gene 12366
4 gene 35.225897 35.262222 positive MGI_C57BL6J_3649554 Gm12367 ENSEMBL:ENSMUSG00000084828 MGI:3649554 lncRNA gene predicted gene 12367
4 pseudogene 35.320686 35.321399 negative MGI_C57BL6J_5010792 Gm18607 NCBI_Gene:100417427 MGI:5010792 pseudogene predicted gene, 18607
4 gene 35.323827 35.329659 negative MGI_C57BL6J_5592831 Gm33672 NCBI_Gene:102636669 MGI:5592831 lncRNA gene predicted gene, 33672
4 pseudogene 35.401058 35.401491 positive MGI_C57BL6J_3649555 Gm12368 ENSEMBL:ENSMUSG00000083934 MGI:3649555 pseudogene predicted gene 12368
4 pseudogene 35.436214 35.436787 positive MGI_C57BL6J_3649559 Gm12365 NCBI_Gene:621227,ENSEMBL:ENSMUSG00000083851 MGI:3649559 pseudogene predicted gene 12365
4 gene 35.696778 36.951747 negative MGI_C57BL6J_2442298 Lingo2 NCBI_Gene:242384,ENSEMBL:ENSMUSG00000045083 MGI:2442298 protein coding gene leucine rich repeat and Ig domain containing 2
4 pseudogene 36.003238 36.004179 negative MGI_C57BL6J_3652093 Gm12369 NCBI_Gene:100417941,ENSEMBL:ENSMUSG00000082169 MGI:3652093 pseudogene predicted gene 12369
4 gene 36.154094 36.154584 negative MGI_C57BL6J_1925173 A330107A15Rik NA NA unclassified gene RIKEN cDNA A330107A15 gene
4 pseudogene 36.444070 36.444884 positive MGI_C57BL6J_3652094 Gm12370 NCBI_Gene:100416256,ENSEMBL:ENSMUSG00000084352 MGI:3652094 pseudogene predicted gene 12370
4 gene 36.645373 36.645453 negative MGI_C57BL6J_3718566 Mir876 miRBase:MI0005480,NCBI_Gene:100124458,ENSEMBL:ENSMUSG00000077851 MGI:3718566 miRNA gene microRNA 876
4 gene 36.668510 36.668586 negative MGI_C57BL6J_3718563 Mir873a miRBase:MI0005550,NCBI_Gene:100124457,ENSEMBL:ENSMUSG00000078057 MGI:3718563 miRNA gene microRNA 873a
4 gene 36.668510 36.668586 positive MGI_C57BL6J_5562760 Mir873b miRBase:MI0021959,NCBI_Gene:102465229,ENSEMBL:ENSMUSG00000106425 MGI:5562760 miRNA gene microRNA 873b
4 gene 36.756048 36.756154 positive MGI_C57BL6J_5453091 Gm23314 ENSEMBL:ENSMUSG00000087843 MGI:5453091 snRNA gene predicted gene, 23314
4 gene 36.952966 36.988513 positive MGI_C57BL6J_3652322 Gm12371 NCBI_Gene:100042132,ENSEMBL:ENSMUSG00000084898 MGI:3652322 lncRNA gene predicted gene 12371
4 gene 37.086049 37.099185 positive MGI_C57BL6J_5625154 Gm42269 NCBI_Gene:105247111 MGI:5625154 lncRNA gene predicted gene, 42269
4 pseudogene 37.139107 37.139874 negative MGI_C57BL6J_3650289 Taf9-ps ENSEMBL:ENSMUSG00000080969 MGI:3650289 pseudogene TATA-box binding protein associated factor 9, pseudogene
4 pseudogene 37.238674 37.239181 negative MGI_C57BL6J_3652320 Rpl23a-ps6 NCBI_Gene:621458,ENSEMBL:ENSMUSG00000082732 MGI:3652320 pseudogene ribosomal protein 23A, pseudogene 6
4 gene 37.249403 37.332515 positive MGI_C57BL6J_3652319 Gm12374 NCBI_Gene:102636890,ENSEMBL:ENSMUSG00000086026 MGI:3652319 lncRNA gene predicted gene 12374
4 gene 37.297905 37.298025 positive MGI_C57BL6J_5452509 Gm22732 ENSEMBL:ENSMUSG00000088718 MGI:5452509 snoRNA gene predicted gene, 22732
4 pseudogene 37.880081 37.889918 negative MGI_C57BL6J_3652318 Gm12375 NCBI_Gene:100417942,ENSEMBL:ENSMUSG00000083983 MGI:3652318 pseudogene predicted gene 12375
4 pseudogene 37.970874 37.972334 positive MGI_C57BL6J_3651610 Gm12378 NCBI_Gene:277771,ENSEMBL:ENSMUSG00000080057 MGI:3651610 pseudogene predicted gene 12378
4 pseudogene 38.028845 38.029273 positive MGI_C57BL6J_3651855 Gm12379 ENSEMBL:ENSMUSG00000082899 MGI:3651855 pseudogene predicted gene 12379
4 pseudogene 38.263918 38.264461 positive MGI_C57BL6J_3651854 Gm12380 ENSEMBL:ENSMUSG00000084148 MGI:3651854 pseudogene predicted gene 12380
4 gene 38.571667 38.855483 negative MGI_C57BL6J_3651851 Gm12381 NCBI_Gene:102636968,ENSEMBL:ENSMUSG00000085632 MGI:3651851 lncRNA gene predicted gene 12381
4 pseudogene 38.663809 38.664730 positive MGI_C57BL6J_3651853 Gm12382 NCBI_Gene:665520,ENSEMBL:ENSMUSG00000081427 MGI:3651853 pseudogene predicted gene 12382
4 pseudogene 39.154610 39.155248 negative MGI_C57BL6J_5010189 Gm18004 NCBI_Gene:100416253 MGI:5010189 pseudogene predicted gene, 18004
4 gene 39.259631 39.259794 negative MGI_C57BL6J_5455358 Gm25581 ENSEMBL:ENSMUSG00000065344 MGI:5455358 snRNA gene predicted gene, 25581
4 pseudogene 39.263544 39.264303 positive MGI_C57BL6J_3651852 Gm12383 NCBI_Gene:100416257,ENSEMBL:ENSMUSG00000082238 MGI:3651852 pseudogene predicted gene 12383
4 gene 39.295463 39.295588 positive MGI_C57BL6J_5453384 Gm23607 ENSEMBL:ENSMUSG00000077738 MGI:5453384 snoRNA gene predicted gene, 23607
4 pseudogene 39.383244 39.388661 positive MGI_C57BL6J_5625155 Gm42270 NCBI_Gene:105247112 MGI:5625155 pseudogene predicted gene, 42270
4 gene 39.398045 39.450249 negative MGI_C57BL6J_4937921 Gm17094 NCBI_Gene:102637035,ENSEMBL:ENSMUSG00000090839 MGI:4937921 lncRNA gene predicted gene 17094
4 gene 39.450293 39.451780 positive MGI_C57BL6J_1922721 1700009N14Rik NCBI_Gene:75471,ENSEMBL:ENSMUSG00000028287 MGI:1922721 protein coding gene RIKEN cDNA 1700009N14 gene
4 gene 39.495705 39.508994 negative MGI_C57BL6J_5625156 Gm42271 NCBI_Gene:105247113 MGI:5625156 lncRNA gene predicted gene, 42271
4 gene 39.708728 39.712169 negative MGI_C57BL6J_5625157 Gm42272 NCBI_Gene:105247114 MGI:5625157 lncRNA gene predicted gene, 42272
4 gene 39.714710 39.791320 negative MGI_C57BL6J_5593166 Gm34007 NCBI_Gene:102637113 MGI:5593166 lncRNA gene predicted gene, 34007
4 pseudogene 39.767599 39.768454 positive MGI_C57BL6J_3651224 Gm12385 NCBI_Gene:435775,ENSEMBL:ENSMUSG00000082302 MGI:3651224 pseudogene predicted gene 12385
4 gene 39.788744 39.792398 positive MGI_C57BL6J_5593230 Gm34071 NCBI_Gene:102637197 MGI:5593230 lncRNA gene predicted gene, 34071
4 pseudogene 39.823430 39.824365 positive MGI_C57BL6J_3651222 Gm12384 NCBI_Gene:329824,ENSEMBL:ENSMUSG00000083271 MGI:3651222 pseudogene predicted gene 12384
4 pseudogene 39.844187 39.844874 negative MGI_C57BL6J_3651977 Gm12386 ENSEMBL:ENSMUSG00000082022 MGI:3651977 pseudogene predicted gene 12386
4 gene 39.865687 39.865768 positive MGI_C57BL6J_5452627 Gm22850 ENSEMBL:ENSMUSG00000088339 MGI:5452627 snRNA gene predicted gene, 22850
4 pseudogene 39.895166 39.896162 negative MGI_C57BL6J_3651413 Gm12387 NCBI_Gene:621880,ENSEMBL:ENSMUSG00000084220 MGI:3651413 pseudogene predicted gene 12387
4 gene 39.936874 39.952708 negative MGI_C57BL6J_5593291 Gm34132 NCBI_Gene:102637272 MGI:5593291 lncRNA gene predicted gene, 34132
4 gene 39.981497 39.981558 negative MGI_C57BL6J_5455864 Gm26087 ENSEMBL:ENSMUSG00000088526 MGI:5455864 snRNA gene predicted gene, 26087
4 pseudogene 40.069101 40.070987 positive MGI_C57BL6J_3651412 Gm12388 NCBI_Gene:100417558,ENSEMBL:ENSMUSG00000083202 MGI:3651412 pseudogene predicted gene 12388
4 pseudogene 40.116816 40.117233 negative MGI_C57BL6J_3650084 Gm12389 ENSEMBL:ENSMUSG00000081352 MGI:3650084 pseudogene predicted gene 12389
4 gene 40.143081 40.199009 positive MGI_C57BL6J_87879 Aco1 NCBI_Gene:11428,ENSEMBL:ENSMUSG00000028405 MGI:87879 protein coding gene aconitase 1
4 gene 40.203773 40.239828 negative MGI_C57BL6J_2442858 Ddx58 NCBI_Gene:230073,ENSEMBL:ENSMUSG00000040296 MGI:2442858 protein coding gene DEAD (Asp-Glu-Ala-Asp) box polypeptide 58
4 gene 40.259601 40.269850 negative MGI_C57BL6J_2146189 Topors NCBI_Gene:106021,ENSEMBL:ENSMUSG00000036822 MGI:2146189 protein coding gene topoisomerase I binding, arginine/serine-rich
4 gene 40.269579 40.270940 positive MGI_C57BL6J_1913684 Smim27 NCBI_Gene:100504309,ENSEMBL:ENSMUSG00000028407 MGI:1913684 protein coding gene small integral membrane protein 27
4 gene 40.270591 40.279421 negative MGI_C57BL6J_2684983 Ndufb6 NCBI_Gene:230075,ENSEMBL:ENSMUSG00000071014 MGI:2684983 protein coding gene NADH:ubiquinone oxidoreductase subunit B6
4 gene 40.313232 40.317719 positive MGI_C57BL6J_1923069 4930509K18Rik NCBI_Gene:75819,ENSEMBL:ENSMUSG00000087137 MGI:1923069 lncRNA gene RIKEN cDNA 4930509K18 gene
4 gene 40.458939 40.459033 negative MGI_C57BL6J_5453115 Gm23338 ENSEMBL:ENSMUSG00000089585 MGI:5453115 snoRNA gene predicted gene, 23338
4 gene 40.472180 40.477168 positive MGI_C57BL6J_2444167 Tmem215 NCBI_Gene:320500,ENSEMBL:ENSMUSG00000046593 MGI:2444167 protein coding gene transmembrane protein 215
4 gene 40.482840 40.525548 negative MGI_C57BL6J_1918543 4933428C19Rik NCBI_Gene:71293,ENSEMBL:ENSMUSG00000086355 MGI:1918543 lncRNA gene RIKEN cDNA 4933428C19 gene
4 pseudogene 40.653991 40.657408 negative MGI_C57BL6J_5826493 Gm46856 NCBI_Gene:108168949 MGI:5826493 pseudogene predicted gene, 46856
4 pseudogene 40.678332 40.678778 positive MGI_C57BL6J_3650809 Gm12391 ENSEMBL:ENSMUSG00000081720 MGI:3650809 pseudogene predicted gene 12391
4 gene 40.682078 40.721667 negative MGI_C57BL6J_1913658 Aptx NCBI_Gene:66408,ENSEMBL:ENSMUSG00000028411 MGI:1913658 protein coding gene aprataxin
4 pseudogene 40.716595 40.716991 negative MGI_C57BL6J_3650810 Gm12390 ENSEMBL:ENSMUSG00000082008 MGI:3650810 pseudogene predicted gene 12390
4 gene 40.720154 40.722841 negative MGI_C57BL6J_3779584 Gm6297 NCBI_Gene:622208,ENSEMBL:ENSMUSG00000097123 MGI:3779584 lncRNA gene predicted gene 6297
4 gene 40.722150 40.737149 positive MGI_C57BL6J_1270129 Dnaja1 NCBI_Gene:15502,ENSEMBL:ENSMUSG00000028410 MGI:1270129 protein coding gene DnaJ heat shock protein family (Hsp40) member A1
4 gene 40.722917 40.722995 positive MGI_C57BL6J_2676882 Mir207 miRBase:MI0000250,NCBI_Gene:387203,ENSEMBL:ENSMUSG00000065452 MGI:2676882 miRNA gene microRNA 207
4 gene 40.735649 40.757923 negative MGI_C57BL6J_1915546 Smu1 NCBI_Gene:74255,ENSEMBL:ENSMUSG00000028409 MGI:1915546 protein coding gene smu-1 suppressor of mec-8 and unc-52 homolog (C. elegans)
4 gene 40.772976 40.776776 positive MGI_C57BL6J_5593372 Gm34213 NCBI_Gene:102637386 MGI:5593372 lncRNA gene predicted gene, 34213
4 pseudogene 40.775133 40.775771 negative MGI_C57BL6J_3649201 Psenen-ps NCBI_Gene:100042305,ENSEMBL:ENSMUSG00000056412 MGI:3649201 pseudogene presenilin enhancer gamma secretase subunit, pseudogene
4 gene 40.804582 40.855712 negative MGI_C57BL6J_95705 B4galt1 NCBI_Gene:14595,ENSEMBL:ENSMUSG00000028413 MGI:95705 protein coding gene UDP-Gal:betaGlcNAc beta 1,4- galactosyltransferase, polypeptide 1
4 gene 40.850056 40.850138 negative MGI_C57BL6J_4950448 Mir5123 miRBase:MI0018034,NCBI_Gene:100628614,ENSEMBL:ENSMUSG00000096377 MGI:4950448 miRNA gene microRNA 5123
4 gene 40.850144 40.850226 negative MGI_C57BL6J_5453889 Gm24112 ENSEMBL:ENSMUSG00000094959 MGI:5453889 miRNA gene predicted gene, 24112
4 gene 40.850320 40.850402 negative MGI_C57BL6J_5455708 Gm25931 ENSEMBL:ENSMUSG00000095871 MGI:5455708 miRNA gene predicted gene, 25931
4 gene 40.872419 40.900371 positive MGI_C57BL6J_5593448 Gm34289 NCBI_Gene:102637497 MGI:5593448 lncRNA gene predicted gene, 34289
4 pseudogene 40.911693 40.913357 negative MGI_C57BL6J_3649202 Gm12397 NCBI_Gene:100039668,ENSEMBL:ENSMUSG00000081309 MGI:3649202 pseudogene predicted gene 12397
4 gene 40.920052 40.931395 positive MGI_C57BL6J_1341848 Spink4 NCBI_Gene:20731,ENSEMBL:ENSMUSG00000028415 MGI:1341848 protein coding gene serine peptidase inhibitor, Kazal type 4
4 gene 40.936398 40.948294 negative MGI_C57BL6J_108047 Bag1 NCBI_Gene:12017,ENSEMBL:ENSMUSG00000028416 MGI:108047 protein coding gene BCL2-associated athanogene 1
4 gene 40.948407 40.965303 positive MGI_C57BL6J_1924209 Chmp5 NCBI_Gene:76959,ENSEMBL:ENSMUSG00000028419 MGI:1924209 protein coding gene charged multivesicular body protein 5
4 gene 40.970906 41.025993 positive MGI_C57BL6J_1921414 Nfx1 NCBI_Gene:74164,ENSEMBL:ENSMUSG00000028423 MGI:1921414 protein coding gene nuclear transcription factor, X-box binding 1
4 gene 40.993695 40.993758 positive MGI_C57BL6J_4834308 Mir3094 miRBase:MI0014087,NCBI_Gene:100526501,ENSEMBL:ENSMUSG00000092862 MGI:4834308 miRNA gene microRNA 3094
4 gene 41.033074 41.048295 negative MGI_C57BL6J_1314647 Aqp7 NCBI_Gene:11832,ENSEMBL:ENSMUSG00000028427 MGI:1314647 protein coding gene aquaporin 7
4 gene 41.050220 41.050326 positive MGI_C57BL6J_5455414 Gm25637 ENSEMBL:ENSMUSG00000088154 MGI:5455414 snRNA gene predicted gene, 25637
4 gene 41.092722 41.098183 negative MGI_C57BL6J_1333777 Aqp3 NCBI_Gene:11828,ENSEMBL:ENSMUSG00000028435 MGI:1333777 protein coding gene aquaporin 3
4 gene 41.114427 41.124455 negative MGI_C57BL6J_2140151 Nol6 NCBI_Gene:230082,ENSEMBL:ENSMUSG00000028430 MGI:2140151 protein coding gene nucleolar protein family 6 (RNA-associated)
4 pseudogene 41.132511 41.132844 negative MGI_C57BL6J_3650110 Gm12402 ENSEMBL:ENSMUSG00000081437 MGI:3650110 pseudogene predicted gene 12402
4 gene 41.135743 41.193380 positive MGI_C57BL6J_1914865 Ube2r2 NCBI_Gene:67615,ENSEMBL:ENSMUSG00000036241 MGI:1914865 protein coding gene ubiquitin-conjugating enzyme E2R 2
4 pseudogene 41.168425 41.169604 positive MGI_C57BL6J_3650109 Gm12403 NCBI_Gene:102637678,ENSEMBL:ENSMUSG00000082186 MGI:3650109 pseudogene predicted gene 12403
4 gene 41.172742 41.172844 negative MGI_C57BL6J_5454427 Gm24650 ENSEMBL:ENSMUSG00000087730 MGI:5454427 snRNA gene predicted gene, 24650
4 gene 41.177454 41.179633 positive MGI_C57BL6J_1924196 2310029O18Rik NA NA unclassified gene RIKEN cDNA 2310029O18 gene
4 gene 41.194313 41.275321 negative MGI_C57BL6J_1916176 Ubap2 NCBI_Gene:68926,ENSEMBL:ENSMUSG00000028433 MGI:1916176 protein coding gene ubiquitin-associated protein 2
4 gene 41.203057 41.203133 negative MGI_C57BL6J_5452665 Gm22888 ENSEMBL:ENSMUSG00000089265 MGI:5452665 snoRNA gene predicted gene, 22888
4 gene 41.211502 41.211582 negative MGI_C57BL6J_5454614 Gm24837 ENSEMBL:ENSMUSG00000089308 MGI:5454614 snoRNA gene predicted gene, 24837
4 gene 41.213776 41.213853 negative MGI_C57BL6J_5452867 Gm23090 ENSEMBL:ENSMUSG00000093562 MGI:5452867 snoRNA gene predicted gene, 23090
4 pseudogene 41.252617 41.252844 positive MGI_C57BL6J_3651578 Gm12401 ENSEMBL:ENSMUSG00000081866 MGI:3651578 pseudogene predicted gene 12401
4 gene 41.281625 41.285141 negative MGI_C57BL6J_5625158 Gm42273 NCBI_Gene:105247115 MGI:5625158 lncRNA gene predicted gene, 42273
4 gene 41.291300 41.316731 negative MGI_C57BL6J_1916220 Dcaf12 NCBI_Gene:68970,ENSEMBL:ENSMUSG00000028436 MGI:1916220 protein coding gene DDB1 and CUL4 associated factor 12
4 gene 41.303158 41.303272 positive MGI_C57BL6J_4422048 n-R5s183 ENSEMBL:ENSMUSG00000065873 MGI:4422048 rRNA gene nuclear encoded rRNA 5S 183
4 gene 41.312091 41.312198 negative MGI_C57BL6J_5455826 Gm26049 ENSEMBL:ENSMUSG00000087938 MGI:5455826 snRNA gene predicted gene, 26049
4 gene 41.314928 41.321287 positive MGI_C57BL6J_5826528 Gm46891 NCBI_Gene:108169008 MGI:5826528 lncRNA gene predicted gene, 46891
4 gene 41.345848 41.345951 negative MGI_C57BL6J_5455861 Gm26084 ENSEMBL:ENSMUSG00000088528 MGI:5455861 snRNA gene predicted gene, 26084
4 gene 41.348996 41.390525 positive MGI_C57BL6J_2149543 Ubap1 NCBI_Gene:67123,ENSEMBL:ENSMUSG00000028437 MGI:2149543 protein coding gene ubiquitin-associated protein 1
4 gene 41.390745 41.464927 negative MGI_C57BL6J_1918345 Kif24 NCBI_Gene:109242,ENSEMBL:ENSMUSG00000028438 MGI:1918345 protein coding gene kinesin family member 24
4 gene 41.465082 41.480926 positive MGI_C57BL6J_1913651 Nudt2 NCBI_Gene:66401,ENSEMBL:ENSMUSG00000028443 MGI:1913651 protein coding gene nudix (nucleoside diphosphate linked moiety X)-type motif 2
4 gene 41.491847 41.503134 negative MGI_C57BL6J_2140300 Myorg NCBI_Gene:329828,ENSEMBL:ENSMUSG00000046312 MGI:2140300 protein coding gene myogenesis regulating glycosidase (putative)
4 gene 41.505005 41.517333 negative MGI_C57BL6J_1920971 1110017D15Rik NCBI_Gene:73721,ENSEMBL:ENSMUSG00000028441 MGI:1920971 protein coding gene RIKEN cDNA 1110017D15 gene
4 gene 41.517437 41.518929 positive MGI_C57BL6J_1924242 Fam219aos NCBI_Gene:76992,ENSEMBL:ENSMUSG00000036162 MGI:1924242 antisense lncRNA gene family with sequence similarity 219, member A, opposite strand
4 gene 41.517691 41.569538 negative MGI_C57BL6J_1919151 Fam219a NCBI_Gene:71901,ENSEMBL:ENSMUSG00000028439 MGI:1919151 protein coding gene family with sequence similarity 219, member A
4 gene 41.520405 41.525823 positive MGI_C57BL6J_3649601 Gm12404 NCBI_Gene:102637977,ENSEMBL:ENSMUSG00000087623 MGI:3649601 lncRNA gene predicted gene 12404
4 gene 41.569698 41.638158 positive MGI_C57BL6J_1916172 Dnaic1 NCBI_Gene:68922,ENSEMBL:ENSMUSG00000061322 MGI:1916172 protein coding gene dynein, axonemal, intermediate chain 1
4 gene 41.638144 41.640324 negative MGI_C57BL6J_1916888 Enho NCBI_Gene:69638,ENSEMBL:ENSMUSG00000028445 MGI:1916888 protein coding gene energy homeostasis associated
4 gene 41.639378 41.641416 positive MGI_C57BL6J_3650626 Gm12406 ENSEMBL:ENSMUSG00000084761 MGI:3650626 lncRNA gene predicted gene 12406
4 gene 41.642185 41.649726 positive MGI_C57BL6J_3649392 Gm12405 NCBI_Gene:102637788,ENSEMBL:ENSMUSG00000087054 MGI:3649392 lncRNA gene predicted gene 12405
4 gene 41.657498 41.697091 negative MGI_C57BL6J_99605 Cntfr NCBI_Gene:12804,ENSEMBL:ENSMUSG00000028444 MGI:99605 protein coding gene ciliary neurotrophic factor receptor
4 gene 41.699989 41.769474 positive MGI_C57BL6J_107426 Il11ra1 NCBI_Gene:16157,ENSEMBL:ENSMUSG00000073889 MGI:107426 protein coding gene interleukin 11 receptor, alpha chain 1
4 gene 41.712026 41.714111 negative MGI_C57BL6J_1917211 Rpp25l NCBI_Gene:69961,ENSEMBL:ENSMUSG00000036114 MGI:1917211 protein coding gene ribonuclease P/MRP 25 subunit-like
4 gene 41.714798 41.723170 negative MGI_C57BL6J_1859251 Dctn3 NCBI_Gene:53598,ENSEMBL:ENSMUSG00000028447 MGI:1859251 protein coding gene dynactin 3
4 gene 41.723831 41.731142 negative MGI_C57BL6J_3650624 Arid3c NCBI_Gene:550619,ENSEMBL:ENSMUSG00000066224 MGI:3650624 protein coding gene AT rich interactive domain 3C (BRIGHT-like)
4 gene 41.738493 41.756157 negative MGI_C57BL6J_1195268 Sigmar1 NCBI_Gene:18391,ENSEMBL:ENSMUSG00000036078 MGI:1195268 protein coding gene sigma non-opioid intracellular receptor 1
4 gene 41.743188 41.755772 negative MGI_C57BL6J_5625159 Gm42274 NA NA lncRNA gene predicted gene%2c 42274
4 gene 41.755228 41.759224 positive MGI_C57BL6J_95638 Galt NCBI_Gene:14430,ENSEMBL:ENSMUSG00000036073 MGI:95638 protein coding gene galactose-1-phosphate uridyl transferase
4 gene 41.769467 41.774247 negative MGI_C57BL6J_1343459 Ccl27a NCBI_Gene:20301,ENSEMBL:ENSMUSG00000073888 MGI:1343459 protein coding gene chemokine (C-C motif) ligand 27A
4 pseudogene 41.791784 41.793745 negative MGI_C57BL6J_3693096 Gm12407 NCBI_Gene:100039789,ENSEMBL:ENSMUSG00000095298 MGI:3693096 pseudogene predicted gene 12407
4 gene 41.804418 42.619111 negative MGI_C57BL6J_1922276 4930466F19Rik NA NA protein coding gene RIKEN cDNA 4930466F19 gene
4 pseudogene 41.805506 41.810884 positive MGI_C57BL6J_3708690 Gm10601 NCBI_Gene:100042466,ENSEMBL:ENSMUSG00000082962 MGI:3708690 pseudogene predicted pseudogene 10601
4 pseudogene 41.813109 41.813803 positive MGI_C57BL6J_5625160 Gm42275 NCBI_Gene:105247117 MGI:5625160 pseudogene predicted gene, 42275
4 gene 41.830954 41.832737 negative MGI_C57BL6J_5589195 Gm30036 NCBI_Gene:102631788 MGI:5589195 lncRNA gene predicted gene, 30036
4 pseudogene 41.865242 41.887262 positive MGI_C57BL6J_5434430 Gm21075 NCBI_Gene:100861610 MGI:5434430 pseudogene predicted gene, 21075
4 gene 41.887928 41.890290 positive MGI_C57BL6J_5588960 Gm29801 NCBI_Gene:101056225 MGI:5588960 protein coding gene predicted gene, 29801
4 gene 41.889832 41.893163 positive MGI_C57BL6J_5588963 Gm29804 NCBI_Gene:101056232 MGI:5588963 protein coding gene predicted gene, 29804
4 gene 41.893278 41.942092 negative MGI_C57BL6J_3701135 Gm13307 ENSEMBL:ENSMUSG00000085730 MGI:3701135 lncRNA gene predicted gene 13307
4 pseudogene 41.893388 41.895399 positive MGI_C57BL6J_3705777 Gm13302 NCBI_Gene:101056144,ENSEMBL:ENSMUSG00000084010 MGI:3705777 pseudogene predicted gene 13302
4 gene 41.903610 41.904743 positive MGI_C57BL6J_5434896 Gm21541 NCBI_Gene:100862177,ENSEMBL:ENSMUSG00000094065 MGI:5434896 protein coding gene predicted gene, 21541
4 pseudogene 41.921270 41.923225 positive MGI_C57BL6J_1891387 Ccl19-ps1 NCBI_Gene:100861618,ENSEMBL:ENSMUSG00000082902 MGI:1891387 pseudogene chemokine (C-C motif) ligand 19, pseudogene 1
4 gene 41.941572 41.943124 positive MGI_C57BL6J_5434234 Gm20878 NCBI_Gene:100041579,ENSEMBL:ENSMUSG00000078747 MGI:5434234 protein coding gene predicted gene, 20878
4 gene 41.956717 41.971858 positive MGI_C57BL6J_5434294 Fam205a4 NCBI_Gene:100043920,ENSEMBL:ENSMUSG00000078746 MGI:5434294 protein coding gene family with sequence similarity 205, member A4
4 gene 41.986709 42.832366 positive MGI_C57BL6J_2441853 B230220N19Rik NA NA unclassified non-coding RNA gene RIKEN cDNA B230220N19 gene
4 gene 41.989486 41.992392 negative MGI_C57BL6J_5595721 Gm36562 NCBI_Gene:102640522 MGI:5595721 lncRNA gene predicted gene, 36562
4 pseudogene 42.021267 42.035425 negative MGI_C57BL6J_5434448 Gm21093 NCBI_Gene:100861635,ENSEMBL:ENSMUSG00000096256 MGI:5434448 pseudogene predicted gene, 21093
4 pseudogene 42.025429 42.026902 negative MGI_C57BL6J_3705775 Gm13303 ENSEMBL:ENSMUSG00000082414 MGI:3705775 pseudogene predicted gene 13303
4 gene 42.034581 42.039512 positive MGI_C57BL6J_5610758 Gm37530 ENSEMBL:ENSMUSG00000103694 MGI:5610758 unclassified gene predicted gene, 37530
4 gene 42.055152 42.089708 positive MGI_C57BL6J_3782065 Gm3892 ENSEMBL:ENSMUSG00000095348 MGI:3782065 lncRNA gene predicted gene 3892
4 gene 42.070757 42.072707 negative MGI_C57BL6J_5434459 Gm21104 NCBI_Gene:100861647 MGI:5434459 protein coding gene predicted gene, 21104
4 gene 42.089373 42.092930 positive MGI_C57BL6J_3782066 Gm3893 NCBI_Gene:100042539,ENSEMBL:ENSMUSG00000094293 MGI:3782066 lncRNA gene predicted gene 3893
4 gene 42.114787 42.115917 positive MGI_C57BL6J_3710514 Gm13304 NCBI_Gene:100504346,ENSEMBL:ENSMUSG00000073878 MGI:3710514 protein coding gene predicted gene 13304
4 gene 42.121613 42.153435 negative MGI_C57BL6J_3701133 Gm13299 ENSEMBL:ENSMUSG00000087577 MGI:3701133 lncRNA gene predicted gene 13299
4 gene 42.132418 42.134376 positive MGI_C57BL6J_3780624 Gm2457 NCBI_Gene:100039848 MGI:3780624 protein coding gene predicted gene, 2457
4 pseudogene 42.132559 42.134171 positive MGI_C57BL6J_1891391 Ccl19-ps3 ENSEMBL:ENSMUSG00000094162 MGI:1891391 pseudogene chemokine (C-C motif) ligand 19, pseudogene 3
4 gene 42.153436 42.158846 positive MGI_C57BL6J_3713752 Gm13306 NCBI_Gene:100039863,ENSEMBL:ENSMUSG00000073877 MGI:3713752 protein coding gene predicted gene 13306
4 gene 42.158842 42.168603 negative MGI_C57BL6J_3801997 Gm13305 NCBI_Gene:100042555,ENSEMBL:ENSMUSG00000073876 MGI:3801997 protein coding gene predicted gene 13305
4 gene 42.170845 42.171337 positive MGI_C57BL6J_1920600 1700045I11Rik ENSEMBL:ENSMUSG00000104526 MGI:1920600 unclassified gene RIKEN cDNA 1700045I11 gene
4 gene 42.172841 42.605012 positive MGI_C57BL6J_3780332 Gm2163 NCBI_Gene:100039331,NCBI_Gene:108169010,ENSEMBL:ENSMUSG00000095779 MGI:3780332 protein coding gene predicted gene 2163
4 gene 42.206998 42.235313 positive MGI_C57BL6J_4937994 Gm17167 ENSEMBL:ENSMUSG00000091542 MGI:4937994 lncRNA gene predicted gene 17167
4 pseudogene 42.214483 42.236503 positive MGI_C57BL6J_3707230 Gm13301 NCBI_Gene:101056185,ENSEMBL:ENSMUSG00000096862,ENSEMBL:ENSMUSG00000118434 MGI:3707230 pseudogene predicted gene 13301
4 gene 42.232136 42.233438 positive MGI_C57BL6J_3710628 Gm10600 ENSEMBL:ENSMUSG00000083929 MGI:3710628 protein coding gene predicted gene 10600
4 pseudogene 42.236114 42.239531 positive MGI_C57BL6J_3704096 Gm5859 NCBI_Gene:545605,ENSEMBL:ENSMUSG00000073879 MGI:3704096 pseudogene predicted pseudogene 5859
4 pseudogene 42.239725 42.242073 positive MGI_C57BL6J_4937908 Gm17081 NCBI_Gene:100310789,ENSEMBL:ENSMUSG00000090338 MGI:4937908 pseudogene predicted gene 17081
4 pseudogene 42.242630 42.244913 positive MGI_C57BL6J_3710582 Gm10599 NCBI_Gene:100042472,ENSEMBL:ENSMUSG00000118458 MGI:3710582 pseudogene predicted pseudogene 10599
4 pseudogene 42.245504 42.247349 positive MGI_C57BL6J_6324740 Gm50470 ENSEMBL:ENSMUSG00000118425 MGI:6324740 pseudogene predicted gene, 50470
4 gene 42.255693 42.256825 positive MGI_C57BL6J_1349182 Ccl21b NCBI_Gene:100042493,ENSEMBL:ENSMUSG00000095675 MGI:1349182 protein coding gene chemokine (C-C motif) ligand 21B (leucine)
4 pseudogene 42.273497 42.275109 positive MGI_C57BL6J_6324741 Gm50471 ENSEMBL:ENSMUSG00000118433 MGI:6324741 pseudogene predicted gene, 50471
4 gene 42.293436 42.293841 negative MGI_C57BL6J_5439449 Gm21980 ENSEMBL:ENSMUSG00000096327 MGI:5439449 lncRNA gene predicted gene 21980
4 gene 42.293834 42.294898 positive MGI_C57BL6J_5439404 Gm21953 NCBI_Gene:621580,ENSEMBL:ENSMUSG00000094695 MGI:5439404 protein coding gene predicted gene, 21953
4 gene 42.308931 42.324072 positive MGI_C57BL6J_5434953 Fam205a3 NCBI_Gene:100862261,ENSEMBL:ENSMUSG00000093996 MGI:5434953 protein coding gene family with sequence similarity 205, member A3
4 pseudogene 42.373478 42.379575 negative MGI_C57BL6J_5826494 Gm46857 NCBI_Gene:108168950 MGI:5826494 pseudogene predicted gene, 46857
4 pseudogene 42.373478 42.386157 negative MGI_C57BL6J_5826529 Gm46892 NCBI_Gene:108169011 MGI:5826529 pseudogene predicted gene, 46892
4 gene 42.438945 42.439974 positive MGI_C57BL6J_5434941 Gm21586 NCBI_Gene:100862247,ENSEMBL:ENSMUSG00000095234 MGI:5434941 protein coding gene predicted gene, 21586
4 pseudogene 42.453369 42.473021 positive MGI_C57BL6J_3823028 Gm3883 NCBI_Gene:100042519,ENSEMBL:ENSMUSG00000093909 MGI:3823028 pseudogene predicted gene 3883
4 gene 42.522437 42.651053 negative MGI_C57BL6J_3701946 Fam205a2 NCBI_Gene:545611,ENSEMBL:ENSMUSG00000094066 MGI:3701946 protein coding gene family with sequence similarity 205, member A2
4 pseudogene 42.552478 42.587038 positive MGI_C57BL6J_3710526 Gm10593 ENSEMBL:ENSMUSG00000095258 MGI:3710526 pseudogene predicted gene 10593
4 pseudogene 42.568087 42.570083 negative MGI_C57BL6J_1891390 Ccl19-ps2 NCBI_Gene:65958 MGI:1891390 pseudogene chemokine (C-C motif) ligand 19, pseudogene 2
4 gene 42.612121 42.613253 positive MGI_C57BL6J_3711256 Gm10591 NCBI_Gene:100504239,ENSEMBL:ENSMUSG00000096596 MGI:3711256 protein coding gene predicted gene 10591
4 gene 42.629756 42.631714 positive MGI_C57BL6J_3708691 Gm2564 NCBI_Gene:100040035,ENSEMBL:ENSMUSG00000091938 MGI:3708691 protein coding gene predicted gene 2564
4 gene 42.650604 42.656005 positive MGI_C57BL6J_1891389 Ccl27b NCBI_Gene:100040048,ENSEMBL:ENSMUSG00000096826 MGI:1891389 protein coding gene chemokine (C-C motif) ligand 27b
4 gene 42.655275 42.665763 negative MGI_C57BL6J_109123 Il11ra2 NCBI_Gene:16158,ENSEMBL:ENSMUSG00000078735 MGI:109123 protein coding gene interleukin 11 receptor, alpha chain 2
4 gene 42.665778 42.668802 negative MGI_C57BL6J_5625161 Gm42276 NCBI_Gene:105247118 MGI:5625161 lncRNA gene predicted gene, 42276
4 pseudogene 42.708688 42.717688 negative MGI_C57BL6J_5434513 Gm21158 NCBI_Gene:100861715 MGI:5434513 pseudogene predicted gene, 21158
4 gene 42.714926 42.719893 positive MGI_C57BL6J_5439424 Gm21955 ENSEMBL:ENSMUSG00000102504 MGI:5439424 protein coding gene predicted gene, 21955
4 gene 42.734530 42.735465 negative MGI_C57BL6J_1922695 1700008B15Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 1700008B15 gene
4 gene 42.735545 42.846248 positive MGI_C57BL6J_1923202 4930578G10Rik NCBI_Gene:102638670,ENSEMBL:ENSMUSG00000054885 MGI:1923202 protein coding gene RIKEN cDNA 4930578G10 gene
4 gene 42.736593 42.738094 positive MGI_C57BL6J_3650610 Gm12395 ENSEMBL:ENSMUSG00000085910 MGI:3650610 lncRNA gene predicted gene 12395
4 gene 42.754525 42.756577 negative MGI_C57BL6J_1346316 Ccl19 NCBI_Gene:24047,ENSEMBL:ENSMUSG00000071005 MGI:1346316 protein coding gene chemokine (C-C motif) ligand 19
4 gene 42.754525 42.760895 negative MGI_C57BL6J_3780192 Gm2023 NA NA protein coding gene predicted gene 2023
4 gene 42.772860 42.773993 negative MGI_C57BL6J_1349183 Ccl21a NCBI_Gene:18829,ENSEMBL:ENSMUSG00000094686 MGI:1349183 protein coding gene chemokine (C-C motif) ligand 21A (serine)
4 gene 42.772860 42.773993 negative MGI_C57BL6J_3780156 Gm1987 NA NA protein coding gene predicted gene 1987
4 gene 42.781928 42.856771 negative MGI_C57BL6J_3649790 Gm12394 NCBI_Gene:100861727,ENSEMBL:ENSMUSG00000078722 MGI:3649790 protein coding gene predicted gene 12394
4 gene 42.788037 42.790421 positive MGI_C57BL6J_3779142 Gm10931 NA NA unclassified non-coding RNA gene predicted gene 10931
4 gene 42.848067 42.859025 negative MGI_C57BL6J_3651059 Fam205a1 NCBI_Gene:433698,ENSEMBL:ENSMUSG00000078721 MGI:3651059 protein coding gene family with sequence similarity 205, member A1
4 gene 42.868003 42.874234 negative MGI_C57BL6J_2679716 Fam205c NCBI_Gene:277773,ENSEMBL:ENSMUSG00000050141 MGI:2679716 protein coding gene family with sequence similarity 205, member C
4 gene 42.872618 42.944752 positive MGI_C57BL6J_2140712 Phf24 NCBI_Gene:230085,ENSEMBL:ENSMUSG00000036062 MGI:2140712 protein coding gene PHD finger protein 24
4 gene 42.949814 42.959425 positive MGI_C57BL6J_1930018 Dnajb5 NCBI_Gene:56323,ENSEMBL:ENSMUSG00000036052 MGI:1930018 protein coding gene DnaJ heat shock protein family (Hsp40) member B5
4 gene 42.969604 42.983640 positive MGI_C57BL6J_1914567 1700022I11Rik NCBI_Gene:67317,ENSEMBL:ENSMUSG00000028451 MGI:1914567 protein coding gene RIKEN cDNA 1700022I11 gene
4 gene 42.979963 43.000507 negative MGI_C57BL6J_99919 Vcp NCBI_Gene:269523,ENSEMBL:ENSMUSG00000028452 MGI:99919 protein coding gene valosin containing protein
4 gene 43.002337 43.010568 negative MGI_C57BL6J_1926471 Fancg NCBI_Gene:60534,ENSEMBL:ENSMUSG00000028453 MGI:1926471 protein coding gene Fanconi anemia, complementation group G
4 gene 43.017626 43.027696 negative MGI_C57BL6J_1861452 Pigo NCBI_Gene:56703,ENSEMBL:ENSMUSG00000028454 MGI:1861452 protein coding gene phosphatidylinositol glycan anchor biosynthesis, class O
4 gene 43.027690 43.031710 negative MGI_C57BL6J_1913842 Stoml2 NCBI_Gene:66592,ENSEMBL:ENSMUSG00000028455 MGI:1913842 protein coding gene stomatin (Epb7.2)-like 2
4 gene 43.030999 43.032482 positive MGI_C57BL6J_5477137 Gm26643 ENSEMBL:ENSMUSG00000097681 MGI:5477137 lncRNA gene predicted gene, 26643
4 gene 43.032414 43.046220 negative MGI_C57BL6J_2441854 Fam214b NCBI_Gene:230088,ENSEMBL:ENSMUSG00000036002 MGI:2441854 protein coding gene family with sequence similarity 214, member B
4 gene 43.045966 43.053256 positive MGI_C57BL6J_5477375 Gm26881 NCBI_Gene:105247120,ENSEMBL:ENSMUSG00000096974 MGI:5477375 lncRNA gene predicted gene, 26881
4 gene 43.058929 43.264873 positive MGI_C57BL6J_1342278 Unc13b NCBI_Gene:22249,ENSEMBL:ENSMUSG00000028456 MGI:1342278 protein coding gene unc-13 homolog B
4 gene 43.136499 43.136628 negative MGI_C57BL6J_5453486 Gm23709 ENSEMBL:ENSMUSG00000077552 MGI:5453486 snoRNA gene predicted gene, 23709
4 gene 43.201149 43.201213 negative MGI_C57BL6J_5454787 Gm25010 ENSEMBL:ENSMUSG00000089028 MGI:5454787 snRNA gene predicted gene, 25010
4 gene 43.266714 43.373833 positive MGI_C57BL6J_2444287 Atp8b5 NCBI_Gene:320571,ENSEMBL:ENSMUSG00000028457 MGI:2444287 protein coding gene ATPase, class I, type 8B, member 5
4 gene 43.336259 43.340163 negative MGI_C57BL6J_5826488 Gm46851 NCBI_Gene:108168938 MGI:5826488 lncRNA gene predicted gene, 46851
4 gene 43.360355 43.381907 negative MGI_C57BL6J_5826487 Gm46850 NCBI_Gene:108168937 MGI:5826487 lncRNA gene predicted gene, 46850
4 gene 43.381979 43.427092 positive MGI_C57BL6J_2140371 Rusc2 NCBI_Gene:100213,ENSEMBL:ENSMUSG00000035969 MGI:2140371 protein coding gene RUN and SH3 domain containing 2
4 gene 43.427019 43.431593 negative MGI_C57BL6J_2445194 Fam166b NCBI_Gene:329831,ENSEMBL:ENSMUSG00000042788 MGI:2445194 protein coding gene family with sequence similarity 166, member B
4 gene 43.441939 43.448075 positive MGI_C57BL6J_1201675 Tesk1 NCBI_Gene:21754,ENSEMBL:ENSMUSG00000028458 MGI:1201675 protein coding gene testis specific protein kinase 1
4 gene 43.446462 43.454741 negative MGI_C57BL6J_88345 Cd72 NCBI_Gene:12517,ENSEMBL:ENSMUSG00000028459 MGI:88345 protein coding gene CD72 antigen
4 gene 43.482081 43.483734 negative MGI_C57BL6J_1889342 Sit1 NCBI_Gene:54390,ENSEMBL:ENSMUSG00000028460 MGI:1889342 protein coding gene suppression inducing transmembrane adaptor 1
4 gene 43.492783 43.493063 negative MGI_C57BL6J_97937 Rmrp NCBI_Gene:19782,ENSEMBL:ENSMUSG00000088088,ENSEMBL:ENSMUSG00000115420 MGI:97937 RNase MRP RNA gene RNA component of mitochondrial RNAase P
4 gene 43.492900 43.495921 positive MGI_C57BL6J_1913423 Ccdc107 NCBI_Gene:622404,ENSEMBL:ENSMUSG00000028461 MGI:1913423 protein coding gene coiled-coil domain containing 107
4 gene 43.496139 43.508769 negative MGI_C57BL6J_3036286 Arhgef39 NCBI_Gene:230098,ENSEMBL:ENSMUSG00000051517 MGI:3036286 protein coding gene Rho guanine nucleotide exchange factor (GEF) 39
4 gene 43.504428 43.508747 negative MGI_C57BL6J_3649695 Gm12454 ENSEMBL:ENSMUSG00000087142 MGI:3649695 lncRNA gene predicted gene 12454
4 gene 43.506966 43.513729 positive MGI_C57BL6J_2447188 Car9 NCBI_Gene:230099,ENSEMBL:ENSMUSG00000028463 MGI:2447188 protein coding gene carbonic anhydrase 9
4 gene 43.513726 43.523765 negative MGI_C57BL6J_98810 Tpm2 NCBI_Gene:22004,ENSEMBL:ENSMUSG00000028464 MGI:98810 protein coding gene tropomyosin 2, beta
4 gene 43.531513 43.562691 negative MGI_C57BL6J_1099832 Tln1 NCBI_Gene:21894,ENSEMBL:ENSMUSG00000028465 MGI:1099832 protein coding gene talin 1
4 gene 43.562332 43.567060 positive MGI_C57BL6J_99946 Creb3 NCBI_Gene:12913,ENSEMBL:ENSMUSG00000028466 MGI:99946 protein coding gene cAMP responsive element binding protein 3
4 gene 43.566928 43.578873 negative MGI_C57BL6J_2654325 Gba2 NCBI_Gene:230101,ENSEMBL:ENSMUSG00000028467 MGI:2654325 protein coding gene glucosidase beta 2
4 gene 43.568928 43.577648 positive MGI_C57BL6J_5625163 Gm42278 NCBI_Gene:105247121 MGI:5625163 lncRNA gene predicted gene, 42278
4 gene 43.578715 43.587487 positive MGI_C57BL6J_1915956 Rgp1 NCBI_Gene:242406,ENSEMBL:ENSMUSG00000028468 MGI:1915956 protein coding gene RAB6A GEF compex partner 1
4 gene 43.583216 43.584494 negative MGI_C57BL6J_3652339 Msmp NCBI_Gene:100039672,ENSEMBL:ENSMUSG00000078719 MGI:3652339 protein coding gene microseminoprotein, prostate associated
4 gene 43.588072 43.608755 positive MGI_C57BL6J_3649439 Gm12472 ENSEMBL:ENSMUSG00000085351 MGI:3649439 lncRNA gene predicted gene 12472
4 gene 43.603210 43.622371 negative MGI_C57BL6J_5625164 Gm42279 NCBI_Gene:105247122 MGI:5625164 lncRNA gene predicted gene, 42279
4 gene 43.630615 43.651437 positive MGI_C57BL6J_97372 Npr2 NCBI_Gene:230103,ENSEMBL:ENSMUSG00000028469 MGI:97372 protein coding gene natriuretic peptide receptor 2
4 gene 43.631425 43.631557 positive MGI_C57BL6J_5455039 Gm25262 ENSEMBL:ENSMUSG00000092675 MGI:5455039 miRNA gene predicted gene, 25262
4 gene 43.631539 43.641533 negative MGI_C57BL6J_3652337 Gm12473 ENSEMBL:ENSMUSG00000086043 MGI:3652337 lncRNA gene predicted gene 12473
4 gene 43.651330 43.654132 negative MGI_C57BL6J_3056295 Spag8 NCBI_Gene:433700,ENSEMBL:ENSMUSG00000066196 MGI:3056295 protein coding gene sperm associated antigen 8
4 gene 43.654227 43.656488 negative MGI_C57BL6J_1916167 Hint2 NCBI_Gene:68917,ENSEMBL:ENSMUSG00000028470 MGI:1916167 protein coding gene histidine triad nucleotide binding protein 2
4 pseudogene 43.656895 43.663943 negative MGI_C57BL6J_3822518 Gm4748 NCBI_Gene:20366 MGI:3822518 pseudogene predicted gene 4748
4 gene 43.659622 43.669145 negative MGI_C57BL6J_2441678 Fam221b NCBI_Gene:242408,ENSEMBL:ENSMUSG00000043633 MGI:2441678 protein coding gene family with sequence similarity 221, member B
4 pseudogene 43.663916 43.664413 positive MGI_C57BL6J_3650743 Gm12481 NCBI_Gene:100503839,ENSEMBL:ENSMUSG00000043770 MGI:3650743 pseudogene predicted gene 12481
4 gene 43.668971 43.692668 positive MGI_C57BL6J_2441680 Tmem8b NCBI_Gene:242409,ENSEMBL:ENSMUSG00000078716 MGI:2441680 protein coding gene transmembrane protein 8B
4 gene 43.692686 43.692817 positive MGI_C57BL6J_5453034 Gm23257 ENSEMBL:ENSMUSG00000088947 MGI:5453034 rRNA gene predicted gene, 23257
4 gene 43.694784 43.700807 negative MGI_C57BL6J_1860079 Olfr70 NCBI_Gene:56014,ENSEMBL:ENSMUSG00000050215 MGI:1860079 protein coding gene olfactory receptor 70
4 gene 43.704562 43.710255 negative MGI_C57BL6J_1860080 Olfr71 NCBI_Gene:56015,ENSEMBL:ENSMUSG00000046450 MGI:1860080 protein coding gene olfactory receptor 71
4 gene 43.727188 43.728639 positive MGI_C57BL6J_1917945 Hrct1 NCBI_Gene:100039781,ENSEMBL:ENSMUSG00000071001 MGI:1917945 protein coding gene histidine rich carboxyl terminus 1
4 gene 43.730034 43.759462 positive MGI_C57BL6J_1918656 Spaar NCBI_Gene:71406,ENSEMBL:ENSMUSG00000028475 MGI:1918656 protein coding gene small regulatory polypeptide of amino acid response
4 gene 43.748026 43.748643 negative MGI_C57BL6J_1920258 2900073C16Rik NA NA unclassified gene RIKEN cDNA 2900073C16 gene
4 gene 43.751859 43.759464 positive MGI_C57BL6J_2443089 A630077J23Rik NCBI_Gene:319973 MGI:2443089 lncRNA gene RIKEN cDNA A630077J23 gene
4 pseudogene 43.767425 43.768197 negative MGI_C57BL6J_3030103 Olfr269-ps1 NCBI_Gene:257810,ENSEMBL:ENSMUSG00000083417 MGI:3030103 pseudogene olfactory receptor 269, pseudogene 1
4 gene 43.770050 43.771009 negative MGI_C57BL6J_1352686 Olfr159 NCBI_Gene:29849,ENSEMBL:ENSMUSG00000044801 MGI:1352686 protein coding gene olfactory receptor 159
4 pseudogene 43.781365 43.782328 negative MGI_C57BL6J_1352685 Olfr29-ps1 NCBI_Gene:29848,ENSEMBL:ENSMUSG00000111338 MGI:1352685 polymorphic pseudogene olfactory receptor 29, pseudogene 1
4 pseudogene 43.798896 43.800255 negative MGI_C57BL6J_3651196 Gm12492 NCBI_Gene:100418043,ENSEMBL:ENSMUSG00000081329 MGI:3651196 pseudogene predicted gene 12492
4 gene 43.820132 43.823895 negative MGI_C57BL6J_1352683 Olfr156 NCBI_Gene:29846,ENSEMBL:ENSMUSG00000110970 MGI:1352683 protein coding gene olfactory receptor 156
4 gene 43.823154 43.830474 positive MGI_C57BL6J_5589477 Gm30318 NCBI_Gene:102632172 MGI:5589477 lncRNA gene predicted gene, 30318
4 gene 43.830542 43.840201 negative MGI_C57BL6J_1352684 Olfr157 NCBI_Gene:100040268,ENSEMBL:ENSMUSG00000111611 MGI:1352684 protein coding gene olfactory receptor 157
4 gene 43.851565 43.857595 positive MGI_C57BL6J_1352681 Olfr155 NCBI_Gene:29845,ENSEMBL:ENSMUSG00000071000 MGI:1352681 protein coding gene olfactory receptor 155
4 gene 43.875530 43.944806 positive MGI_C57BL6J_1855698 Reck NCBI_Gene:53614,ENSEMBL:ENSMUSG00000028476 MGI:1855698 protein coding gene reversion-inducing-cysteine-rich protein with kazal motifs
4 gene 43.905078 43.905154 positive MGI_C57BL6J_5530647 Gm27265 ENSEMBL:ENSMUSG00000099252 MGI:5530647 unclassified non-coding RNA gene predicted gene, 27265
4 gene 43.955718 43.957476 negative MGI_C57BL6J_5589536 Gm30377 NCBI_Gene:102632247 MGI:5589536 lncRNA gene predicted gene, 30377
4 gene 43.957401 43.979118 positive MGI_C57BL6J_1917770 Glipr2 NCBI_Gene:384009,ENSEMBL:ENSMUSG00000028480 MGI:1917770 protein coding gene GLI pathogenesis-related 2
4 gene 43.983483 43.985533 positive MGI_C57BL6J_3045316 Ccin NCBI_Gene:442829,ENSEMBL:ENSMUSG00000070999 MGI:3045316 protein coding gene calicin
4 gene 44.003816 44.032848 positive MGI_C57BL6J_894297 Clta NCBI_Gene:12757,ENSEMBL:ENSMUSG00000028478 MGI:894297 protein coding gene clathrin, light polypeptide (Lca)
4 gene 44.034075 44.084177 negative MGI_C57BL6J_1354951 Gne NCBI_Gene:50798,ENSEMBL:ENSMUSG00000028479 MGI:1354951 protein coding gene glucosamine (UDP-N-acetyl)-2-epimerase/N-acetylmannosamine kinase
4 gene 44.081289 44.081400 negative MGI_C57BL6J_5452483 Gm22706 ENSEMBL:ENSMUSG00000088532 MGI:5452483 snRNA gene predicted gene, 22706
4 gene 44.092632 44.109311 positive MGI_C57BL6J_3651570 Gm12503 ENSEMBL:ENSMUSG00000087326 MGI:3651570 lncRNA gene predicted gene 12503
4 pseudogene 44.121893 44.124123 positive MGI_C57BL6J_3651567 Gm12504 NCBI_Gene:623796,ENSEMBL:ENSMUSG00000084274 MGI:3651567 pseudogene predicted pseudogene 12504
4 gene 44.126210 44.233789 negative MGI_C57BL6J_1920719 Rnf38 NCBI_Gene:73469,ENSEMBL:ENSMUSG00000035696 MGI:1920719 protein coding gene ring finger protein 38
4 gene 44.221195 44.221267 negative MGI_C57BL6J_4950426 Mir5106 miRBase:MI0018014,NCBI_Gene:100628618,ENSEMBL:ENSMUSG00000092677 MGI:4950426 miRNA gene microRNA 5106
4 gene 44.300876 44.364675 positive MGI_C57BL6J_106924 Melk NCBI_Gene:17279,ENSEMBL:ENSMUSG00000035683 MGI:106924 protein coding gene maternal embryonic leucine zipper kinase
4 pseudogene 44.313427 44.314058 negative MGI_C57BL6J_3651065 Gm12677 ENSEMBL:ENSMUSG00000081127 MGI:3651065 pseudogene predicted gene 12677
4 pseudogene 44.382922 44.383337 positive MGI_C57BL6J_3649235 Gm12455 ENSEMBL:ENSMUSG00000083803 MGI:3649235 pseudogene predicted gene 12455
4 gene 44.412469 44.412595 negative MGI_C57BL6J_5454153 Gm24376 ENSEMBL:ENSMUSG00000077587 MGI:5454153 snoRNA gene predicted gene, 24376
4 gene 44.524757 44.710487 negative MGI_C57BL6J_97489 Pax5 NCBI_Gene:18507,ENSEMBL:ENSMUSG00000014030 MGI:97489 protein coding gene paired box 5
4 gene 44.607491 44.607568 negative MGI_C57BL6J_4950445 Mir5120 miRBase:MI0018029,NCBI_Gene:100628590,ENSEMBL:ENSMUSG00000092761 MGI:4950445 miRNA gene microRNA 5120
4 gene 44.660398 44.685347 positive MGI_C57BL6J_3650646 Gm12462 NCBI_Gene:102632357,ENSEMBL:ENSMUSG00000086211 MGI:3650646 lncRNA gene predicted gene 12462
4 gene 44.669330 44.670897 positive MGI_C57BL6J_1921972 4930517J16Rik ENSEMBL:ENSMUSG00000102880 MGI:1921972 unclassified gene RIKEN cDNA 4930517J16 gene
4 gene 44.702800 44.705110 positive MGI_C57BL6J_1917852 5730488B01Rik NCBI_Gene:70602,ENSEMBL:ENSMUSG00000103995 MGI:1917852 lncRNA gene RIKEN cDNA 5730488B01 gene
4 pseudogene 44.752132 44.753182 negative MGI_C57BL6J_3650648 Gm12463 NCBI_Gene:545618,ENSEMBL:ENSMUSG00000080916 MGI:3650648 pseudogene predicted gene 12463
4 gene 44.755877 44.932215 positive MGI_C57BL6J_2442912 Zcchc7 NCBI_Gene:319885,ENSEMBL:ENSMUSG00000035649 MGI:2442912 protein coding gene zinc finger, CCHC domain containing 7
4 gene 44.865307 44.865431 positive MGI_C57BL6J_5452416 Gm22639 ENSEMBL:ENSMUSG00000094842 MGI:5452416 miRNA gene predicted gene, 22639
4 gene 44.915315 44.919796 positive MGI_C57BL6J_2443263 A630057N01Rik NA NA unclassified gene RIKEN cDNA A630057N01 gene
4 gene 44.943649 44.949133 positive MGI_C57BL6J_3650923 Gm12678 NCBI_Gene:102632657,ENSEMBL:ENSMUSG00000084854 MGI:3650923 lncRNA gene predicted gene 12678
4 gene 44.956562 44.959784 negative MGI_C57BL6J_5589922 Gm30763 NCBI_Gene:102632779 MGI:5589922 lncRNA gene predicted gene, 30763
4 gene 44.967769 44.971096 positive MGI_C57BL6J_3651194 Gm12493 ENSEMBL:ENSMUSG00000086000 MGI:3651194 lncRNA gene predicted gene 12493
4 gene 44.970576 44.978319 negative MGI_C57BL6J_3650924 Gm12679 ENSEMBL:ENSMUSG00000086205 MGI:3650924 lncRNA gene predicted gene 12679
4 gene 44.981394 44.990734 positive MGI_C57BL6J_1923488 Grhpr NCBI_Gene:76238,ENSEMBL:ENSMUSG00000035637 MGI:1923488 protein coding gene glyoxylate reductase/hydroxypyruvate reductase
4 gene 44.991242 45.012412 negative MGI_C57BL6J_1924601 Zbtb5 NCBI_Gene:230119,ENSEMBL:ENSMUSG00000049657 MGI:1924601 protein coding gene zinc finger and BTB domain containing 5
4 gene 45.011687 45.015406 positive MGI_C57BL6J_1920655 1700055D18Rik NCBI_Gene:73405,ENSEMBL:ENSMUSG00000070997 MGI:1920655 lncRNA gene RIKEN cDNA 1700055D18 gene
4 gene 45.018583 45.036565 positive MGI_C57BL6J_1929022 Polr1e NCBI_Gene:64424,ENSEMBL:ENSMUSG00000028318 MGI:1929022 protein coding gene polymerase (RNA) I polypeptide E
4 gene 45.034247 45.084647 negative MGI_C57BL6J_2686937 Fbxo10 NCBI_Gene:269529,ENSEMBL:ENSMUSG00000048232 MGI:2686937 protein coding gene F-box protein 10
4 gene 45.044936 45.061986 positive MGI_C57BL6J_5590098 Gm30939 NCBI_Gene:102633009 MGI:5590098 lncRNA gene predicted gene, 30939
4 gene 45.105208 45.108114 negative MGI_C57BL6J_1915762 Tomm5 NCBI_Gene:68512,ENSEMBL:ENSMUSG00000078713 MGI:1915762 protein coding gene translocase of outer mitochondrial membrane 5
4 pseudogene 45.136250 45.136608 negative MGI_C57BL6J_3649827 Gm12566 ENSEMBL:ENSMUSG00000082628 MGI:3649827 pseudogene predicted gene 12566
4 gene 45.184416 45.285936 positive MGI_C57BL6J_2446274 Frmpd1 NCBI_Gene:666060,ENSEMBL:ENSMUSG00000035615 MGI:2446274 protein coding gene FERM and PDZ domain containing 1
4 gene 45.234723 45.243990 negative MGI_C57BL6J_1925758 Frmpd1os NCBI_Gene:78508,ENSEMBL:ENSMUSG00000086284 MGI:1925758 antisense lncRNA gene FERM and PDZ domain containing 1, opposite strand
4 gene 45.297068 45.316134 positive MGI_C57BL6J_1917184 Trmt10b NCBI_Gene:69934,ENSEMBL:ENSMUSG00000035601 MGI:1917184 protein coding gene tRNA methyltransferase 10B
4 gene 45.316613 45.342732 negative MGI_C57BL6J_1913612 Exosc3 NCBI_Gene:66362,ENSEMBL:ENSMUSG00000028322 MGI:1913612 protein coding gene exosome component 3
4 gene 45.332386 45.336787 negative MGI_C57BL6J_5590176 Gm31017 NCBI_Gene:102633110 MGI:5590176 lncRNA gene predicted gene, 31017
4 pseudogene 45.338637 45.339046 negative MGI_C57BL6J_3650149 Gm12585 NCBI_Gene:666325,ENSEMBL:ENSMUSG00000083541 MGI:3650149 pseudogene predicted gene 12585
4 gene 45.342094 45.379759 positive MGI_C57BL6J_2140179 Dcaf10 NCBI_Gene:242418,ENSEMBL:ENSMUSG00000035572 MGI:2140179 protein coding gene DDB1 and CUL4 associated factor 10
4 gene 45.395923 45.408928 negative MGI_C57BL6J_2684984 Slc25a51 NCBI_Gene:230125,ENSEMBL:ENSMUSG00000045973 MGI:2684984 protein coding gene solute carrier family 25, member 51
4 gene 45.396994 45.397118 negative MGI_C57BL6J_5455469 Gm25692 ENSEMBL:ENSMUSG00000093185 MGI:5455469 miRNA gene predicted gene, 25692
4 gene 45.406213 45.407185 negative MGI_C57BL6J_1924938 9230104K21Rik NA NA unclassified gene RIKEN cDNA 9230104K21 gene
4 gene 45.409390 45.423213 positive MGI_C57BL6J_5826489 Gm46852 NCBI_Gene:108168939 MGI:5826489 lncRNA gene predicted gene, 46852
4 gene 45.423276 45.532470 negative MGI_C57BL6J_98294 Shb NCBI_Gene:230126,ENSEMBL:ENSMUSG00000044813 MGI:98294 protein coding gene src homology 2 domain-containing transforming protein B
4 gene 45.500485 45.500552 negative MGI_C57BL6J_5452295 Gm22518 ENSEMBL:ENSMUSG00000088892 MGI:5452295 miRNA gene predicted gene, 22518
4 gene 45.548743 45.548849 positive MGI_C57BL6J_5451832 Gm22055 ENSEMBL:ENSMUSG00000065322 MGI:5451832 snRNA gene predicted gene, 22055
4 pseudogene 45.550017 45.550532 positive MGI_C57BL6J_3649918 Gm12411 NCBI_Gene:100040140,ENSEMBL:ENSMUSG00000081559 MGI:3649918 pseudogene predicted gene 12411
4 gene 45.639368 45.646111 positive MGI_C57BL6J_3649921 Gm12408 NCBI_Gene:100040557,ENSEMBL:ENSMUSG00000085980 MGI:3649921 lncRNA gene predicted gene 12408
4 gene 45.683589 45.723706 positive MGI_C57BL6J_2685675 Gm829 NCBI_Gene:329839,ENSEMBL:ENSMUSG00000073860 MGI:2685675 lncRNA gene predicted gene 829
4 gene 45.715169 45.716421 positive MGI_C57BL6J_3650364 Gm12410 ENSEMBL:ENSMUSG00000085305 MGI:3650364 lncRNA gene predicted gene 12410
4 gene 45.723773 45.740301 negative MGI_C57BL6J_5590722 Gm31563 NCBI_Gene:102633832 MGI:5590722 lncRNA gene predicted gene, 31563
4 gene 45.762377 45.764223 negative MGI_C57BL6J_3649923 Gm12409 NCBI_Gene:100040567,ENSEMBL:ENSMUSG00000085876 MGI:3649923 lncRNA gene predicted gene 12409
4 pseudogene 45.776882 45.777209 negative MGI_C57BL6J_3649919 Gm12412 ENSEMBL:ENSMUSG00000083685 MGI:3649919 pseudogene predicted gene 12412
4 gene 45.799022 45.804608 positive MGI_C57BL6J_1919785 Aldh1b1 NCBI_Gene:72535,ENSEMBL:ENSMUSG00000035561 MGI:1919785 protein coding gene aldehyde dehydrogenase 1 family, member B1
4 gene 45.809468 45.826923 negative MGI_C57BL6J_1933198 Igfbpl1 NCBI_Gene:75426,ENSEMBL:ENSMUSG00000035551 MGI:1933198 protein coding gene insulin-like growth factor binding protein-like 1
4 gene 45.822565 45.887010 positive MGI_C57BL6J_1921402 Stra6l NCBI_Gene:74152,ENSEMBL:ENSMUSG00000028327 MGI:1921402 protein coding gene STRA6-like
4 gene 45.890303 45.950774 positive MGI_C57BL6J_2685871 Ccdc180 NCBI_Gene:381522,ENSEMBL:ENSMUSG00000035539 MGI:2685871 protein coding gene coiled-coil domain containing 180
4 gene 45.965027 46.034766 positive MGI_C57BL6J_2140279 Tdrd7 NCBI_Gene:100121,ENSEMBL:ENSMUSG00000035517 MGI:2140279 protein coding gene tudor domain containing 7
4 gene 46.038935 46.116032 positive MGI_C57BL6J_98775 Tmod1 NCBI_Gene:21916,ENSEMBL:ENSMUSG00000028328 MGI:98775 protein coding gene tropomodulin 1
4 gene 46.114746 46.138694 negative MGI_C57BL6J_3039624 Tstd2 NCBI_Gene:272027,ENSEMBL:ENSMUSG00000035495 MGI:3039624 protein coding gene thiosulfate sulfurtransferase (rhodanese)-like domain containing 2
4 gene 46.118180 46.118446 positive MGI_C57BL6J_5453027 Gm23250 ENSEMBL:ENSMUSG00000088069 MGI:5453027 unclassified non-coding RNA gene predicted gene, 23250
4 gene 46.138511 46.172403 positive MGI_C57BL6J_1891840 Ncbp1 NCBI_Gene:433702,ENSEMBL:ENSMUSG00000028330 MGI:1891840 protein coding gene nuclear cap binding protein subunit 1
4 gene 46.155347 46.196353 negative MGI_C57BL6J_99135 Xpa NCBI_Gene:22590,ENSEMBL:ENSMUSG00000028329 MGI:99135 protein coding gene xeroderma pigmentosum, complementation group A
4 gene 46.202444 46.207252 positive MGI_C57BL6J_5590776 Gm31617 NCBI_Gene:102633902 MGI:5590776 lncRNA gene predicted gene, 31617
4 pseudogene 46.242989 46.243929 negative MGI_C57BL6J_3650375 Gm12444 NCBI_Gene:624430,ENSEMBL:ENSMUSG00000082194 MGI:3650375 pseudogene predicted gene 12444
4 pseudogene 46.273819 46.274936 negative MGI_C57BL6J_3650256 Gm12445 NCBI_Gene:666379,ENSEMBL:ENSMUSG00000081483 MGI:3650256 pseudogene predicted gene 12445
4 gene 46.300007 46.345515 negative MGI_C57BL6J_3651433 Gm12446 ENSEMBL:ENSMUSG00000087383 MGI:3651433 lncRNA gene predicted gene 12446
4 pseudogene 46.322891 46.327767 positive MGI_C57BL6J_3650247 Gm12447 NCBI_Gene:666389,ENSEMBL:ENSMUSG00000080816 MGI:3650247 pseudogene predicted gene 12447
4 gene 46.327900 46.330655 positive MGI_C57BL6J_5625165 Gm42280 NCBI_Gene:105247123 MGI:5625165 lncRNA gene predicted gene, 42280
4 gene 46.343609 46.346412 positive MGI_C57BL6J_1353500 Foxe1 NCBI_Gene:110805,ENSEMBL:ENSMUSG00000070990 MGI:1353500 protein coding gene forkhead box E1
4 gene 46.376504 46.393557 negative MGI_C57BL6J_1922003 Trmo NCBI_Gene:74753,ENSEMBL:ENSMUSG00000028331 MGI:1922003 protein coding gene tRNA methyltransferase O
4 gene 46.393989 46.413506 negative MGI_C57BL6J_2136910 Hemgn NCBI_Gene:93966,ENSEMBL:ENSMUSG00000028332 MGI:2136910 protein coding gene hemogen
4 pseudogene 46.419980 46.420302 negative MGI_C57BL6J_3651437 Gm12443 ENSEMBL:ENSMUSG00000082242 MGI:3651437 pseudogene predicted gene 12443
4 gene 46.450902 46.472657 positive MGI_C57BL6J_1914878 Anp32b NCBI_Gene:67628,ENSEMBL:ENSMUSG00000028333 MGI:1914878 protein coding gene acidic (leucine-rich) nuclear phosphoprotein 32 family, member B
4 gene 46.489248 46.503632 positive MGI_C57BL6J_2149820 Nans NCBI_Gene:94181,ENSEMBL:ENSMUSG00000028334 MGI:2149820 protein coding gene N-acetylneuraminic acid synthase (sialic acid synthase)
4 gene 46.493781 46.536154 negative MGI_C57BL6J_1921985 Trim14 NCBI_Gene:74735,ENSEMBL:ENSMUSG00000039853 MGI:1921985 protein coding gene tripartite motif-containing 14
4 gene 46.495155 46.495285 positive MGI_C57BL6J_5452024 Gm22247 ENSEMBL:ENSMUSG00000064410 MGI:5452024 snoRNA gene predicted gene, 22247
4 gene 46.535901 46.539883 positive MGI_C57BL6J_4439655 Gm16731 NCBI_Gene:105247126,ENSEMBL:ENSMUSG00000085990 MGI:4439655 lncRNA gene predicted gene, 16731
4 gene 46.536937 46.602202 negative MGI_C57BL6J_1345966 Coro2a NCBI_Gene:107684,ENSEMBL:ENSMUSG00000028337 MGI:1345966 protein coding gene coronin, actin binding protein 2A
4 gene 46.567137 46.567915 positive MGI_C57BL6J_1923098 4930566K23Rik NA NA unclassified gene RIKEN cDNA 4930566K23 gene
4 gene 46.577210 46.578786 positive MGI_C57BL6J_2655157 BC005685 NA NA protein coding gene cDNA sequence BC005685
4 gene 46.604390 46.650880 negative MGI_C57BL6J_2652885 Tbc1d2 NCBI_Gene:381605,ENSEMBL:ENSMUSG00000039813 MGI:2652885 protein coding gene TBC1 domain family, member 2
4 gene 46.607149 46.610128 positive MGI_C57BL6J_5591009 Gm31850 NCBI_Gene:102634210 MGI:5591009 lncRNA gene predicted gene, 31850
4 gene 46.621599 46.628333 positive MGI_C57BL6J_5625166 Gm42281 NCBI_Gene:105247124 MGI:5625166 lncRNA gene predicted gene, 42281
4 gene 46.662305 46.991873 negative MGI_C57BL6J_2386030 Gabbr2 NCBI_Gene:242425,ENSEMBL:ENSMUSG00000039809 MGI:2386030 protein coding gene gamma-aminobutyric acid (GABA) B receptor, 2
4 gene 46.860170 46.877704 positive MGI_C57BL6J_5591367 Gm32208 NCBI_Gene:102634676 MGI:5591367 lncRNA gene predicted gene, 32208
4 gene 46.884066 46.897624 positive MGI_C57BL6J_5591294 Gm32135 NCBI_Gene:102634594 MGI:5591294 lncRNA gene predicted gene, 32135
4 gene 47.008316 47.010781 negative MGI_C57BL6J_2685414 Gm568 ENSEMBL:ENSMUSG00000048824 MGI:2685414 lncRNA gene predicted gene 568
4 gene 47.015365 47.057427 negative MGI_C57BL6J_1922941 Anks6 NCBI_Gene:75691,ENSEMBL:ENSMUSG00000066191 MGI:1922941 protein coding gene ankyrin repeat and sterile alpha motif domain containing 6
4 pseudogene 47.041598 47.041960 positive MGI_C57BL6J_3650990 Gm12425 ENSEMBL:ENSMUSG00000081561 MGI:3650990 pseudogene predicted gene 12425
4 pseudogene 47.071646 47.071947 negative MGI_C57BL6J_3651148 Gm12422 ENSEMBL:ENSMUSG00000084199 MGI:3651148 pseudogene predicted gene 12422
4 gene 47.091909 47.123070 positive MGI_C57BL6J_2444664 Galnt12 NCBI_Gene:230145,ENSEMBL:ENSMUSG00000039774 MGI:2444664 protein coding gene polypeptide N-acetylgalactosaminyltransferase 12
4 pseudogene 47.101032 47.101478 positive MGI_C57BL6J_3650991 Gm12424 ENSEMBL:ENSMUSG00000094286 MGI:3650991 pseudogene predicted gene 12424
4 pseudogene 47.171669 47.171803 positive MGI_C57BL6J_3650594 Gm12423 ENSEMBL:ENSMUSG00000083491 MGI:3650594 pseudogene predicted gene 12423
4 gene 47.197487 47.209308 negative MGI_C57BL6J_3650989 Gm12426 NCBI_Gene:102634926,ENSEMBL:ENSMUSG00000087500 MGI:3650989 lncRNA gene predicted gene 12426
4 gene 47.207627 47.313167 positive MGI_C57BL6J_88449 Col15a1 NCBI_Gene:12819,ENSEMBL:ENSMUSG00000028339 MGI:88449 protein coding gene collagen, type XV, alpha 1
4 gene 47.225158 47.245344 negative MGI_C57BL6J_5591476 Gm32317 NCBI_Gene:102634823 MGI:5591476 lncRNA gene predicted gene, 32317
4 gene 47.334016 47.346595 negative MGI_C57BL6J_5625167 Gm42282 NCBI_Gene:105247127 MGI:5625167 lncRNA gene predicted gene, 42282
4 gene 47.353222 47.414931 positive MGI_C57BL6J_98728 Tgfbr1 NCBI_Gene:21812,ENSEMBL:ENSMUSG00000007613 MGI:98728 protein coding gene transforming growth factor, beta receptor I
4 gene 47.353863 47.386136 negative MGI_C57BL6J_5591594 Gm32435 NCBI_Gene:102634986 MGI:5591594 lncRNA gene predicted gene, 32435
4 pseudogene 47.453555 47.455396 positive MGI_C57BL6J_3651061 Gm12430 NCBI_Gene:666473,ENSEMBL:ENSMUSG00000081152 MGI:3651061 pseudogene predicted gene 12430
4 gene 47.465067 47.474370 negative MGI_C57BL6J_1914731 Alg2 NCBI_Gene:56737,ENSEMBL:ENSMUSG00000039740 MGI:1914731 protein coding gene asparagine-linked glycosylation 2 (alpha-1,3-mannosyltransferase)
4 gene 47.474658 47.483242 positive MGI_C57BL6J_1913462 Sec61b NCBI_Gene:66212,ENSEMBL:ENSMUSG00000053317 MGI:1913462 protein coding gene Sec61 beta subunit
4 gene 47.489242 47.494855 negative MGI_C57BL6J_5625168 Gm42283 NCBI_Gene:105247128 MGI:5625168 lncRNA gene predicted gene, 42283
4 gene 47.593337 47.593463 positive MGI_C57BL6J_5530983 Gm27601 ENSEMBL:ENSMUSG00000098999 MGI:5530983 unclassified non-coding RNA gene predicted gene, 27601
4 gene 47.595257 47.606049 negative MGI_C57BL6J_5625169 Gm42284 NCBI_Gene:105247129 MGI:5625169 lncRNA gene predicted gene, 42284
4 gene 47.603417 47.608287 positive MGI_C57BL6J_5591646 Gm32487 NCBI_Gene:102635054 MGI:5591646 lncRNA gene predicted gene, 32487
4 gene 47.603889 47.604008 positive MGI_C57BL6J_5531050 Gm27668 ENSEMBL:ENSMUSG00000098518 MGI:5531050 unclassified non-coding RNA gene predicted gene, 27668
4 gene 47.626015 47.638877 negative MGI_C57BL6J_5591703 Gm32544 NCBI_Gene:102635125 MGI:5591703 lncRNA gene predicted gene, 32544
4 gene 47.827224 47.927365 negative MGI_C57BL6J_5611571 Gm38343 ENSEMBL:ENSMUSG00000102450 MGI:5611571 unclassified gene predicted gene, 38343
4 gene 47.899768 47.913133 positive MGI_C57BL6J_5826520 Gm46883 NCBI_Gene:108168995 MGI:5826520 lncRNA gene predicted gene, 46883
4 gene 47.920755 47.920897 positive MGI_C57BL6J_5452447 Gm22670 ENSEMBL:ENSMUSG00000089349 MGI:5452447 snoRNA gene predicted gene, 22670
4 gene 47.946179 47.951577 negative MGI_C57BL6J_5826490 Gm46853 NCBI_Gene:108168941 MGI:5826490 lncRNA gene predicted gene, 46853
4 gene 47.996456 47.998261 positive MGI_C57BL6J_3649453 Gm12434 ENSEMBL:ENSMUSG00000085660 MGI:3649453 lncRNA gene predicted gene 12434
4 gene 48.044889 48.086447 positive MGI_C57BL6J_1352457 Nr4a3 NCBI_Gene:18124,ENSEMBL:ENSMUSG00000028341 MGI:1352457 protein coding gene nuclear receptor subfamily 4, group A, member 3
4 gene 48.124915 48.186507 positive MGI_C57BL6J_1914977 Stx17 NCBI_Gene:67727,ENSEMBL:ENSMUSG00000061455 MGI:1914977 protein coding gene syntaxin 17
4 gene 48.193323 48.279605 negative MGI_C57BL6J_1923549 Erp44 NCBI_Gene:76299,ENSEMBL:ENSMUSG00000028343 MGI:1923549 protein coding gene endoplasmic reticulum protein 44
4 gene 48.213119 48.213215 negative MGI_C57BL6J_3837123 Mir1958 miRBase:MI0009955,NCBI_Gene:100316708,ENSEMBL:ENSMUSG00000087844 MGI:3837123 miRNA gene microRNA 1958
4 gene 48.279760 48.431956 positive MGI_C57BL6J_1335082 Invs NCBI_Gene:16348,ENSEMBL:ENSMUSG00000028344 MGI:1335082 protein coding gene inversin
4 pseudogene 48.344215 48.345293 negative MGI_C57BL6J_3651950 Gm12435 NCBI_Gene:100417846,ENSEMBL:ENSMUSG00000081953 MGI:3651950 pseudogene predicted gene 12435
4 gene 48.427729 48.429231 negative MGI_C57BL6J_3028047 C030004N09Rik NA NA unclassified gene RIKEN cDNA C030004N09 gene
4 gene 48.430858 48.473465 negative MGI_C57BL6J_1344413 Tex10 NCBI_Gene:269536,ENSEMBL:ENSMUSG00000028345 MGI:1344413 protein coding gene testis expressed gene 10
4 gene 48.539834 48.565892 positive MGI_C57BL6J_1913915 Msantd3 NCBI_Gene:66665,ENSEMBL:ENSMUSG00000039693 MGI:1913915 protein coding gene Myb/SANT-like DNA-binding domain containing 3
4 gene 48.585114 48.663131 positive MGI_C57BL6J_1926810 Tmeff1 NCBI_Gene:230157,ENSEMBL:ENSMUSG00000028347 MGI:1926810 protein coding gene transmembrane protein with EGF-like and two follistatin-like domains 1
4 gene 48.663514 48.673502 positive MGI_C57BL6J_1915266 Cavin4 NCBI_Gene:68016,ENSEMBL:ENSMUSG00000028348 MGI:1915266 protein coding gene caveolae associated 4
4 pseudogene 48.675156 48.675520 positive MGI_C57BL6J_3651708 Gm12439 ENSEMBL:ENSMUSG00000080850 MGI:3651708 pseudogene predicted gene 12439
4 pseudogene 48.745515 48.745850 negative MGI_C57BL6J_3651707 Gm12438 ENSEMBL:ENSMUSG00000083091 MGI:3651707 pseudogene predicted gene 12438
4 gene 48.762851 48.762962 negative MGI_C57BL6J_5454350 Gm24573 ENSEMBL:ENSMUSG00000093240 MGI:5454350 rRNA gene predicted gene, 24573
4 gene 48.896499 48.896623 positive MGI_C57BL6J_5453523 Gm23746 ENSEMBL:ENSMUSG00000077417 MGI:5453523 snoRNA gene predicted gene, 23746
4 gene 48.898593 48.963237 positive MGI_C57BL6J_3651705 Gm12436 NCBI_Gene:102635202,ENSEMBL:ENSMUSG00000084787 MGI:3651705 lncRNA gene predicted gene 12436
4 gene 48.970696 48.972165 negative MGI_C57BL6J_1914031 4933437F24Rik NA NA unclassified gene RIKEN cDNA 4933437F24 gene
4 pseudogene 48.972978 48.973315 positive MGI_C57BL6J_3649531 Gm12442 ENSEMBL:ENSMUSG00000083869 MGI:3649531 pseudogene predicted gene 12442
4 gene 49.059273 49.340261 positive MGI_C57BL6J_2445015 Plppr1 NCBI_Gene:272031,ENSEMBL:ENSMUSG00000063446 MGI:2445015 protein coding gene phospholipid phosphatase related 1
4 gene 49.227442 49.244719 negative MGI_C57BL6J_5591816 Gm32657 NCBI_Gene:102635276 MGI:5591816 lncRNA gene predicted gene, 32657
4 gene 49.289298 49.289403 positive MGI_C57BL6J_5452462 Gm22685 ENSEMBL:ENSMUSG00000064782 MGI:5452462 snRNA gene predicted gene, 22685
4 pseudogene 49.341930 49.342706 positive MGI_C57BL6J_3650226 Gm12453 NCBI_Gene:102635389,ENSEMBL:ENSMUSG00000096476 MGI:3650226 pseudogene predicted gene 12453
4 pseudogene 49.350491 49.374643 positive MGI_C57BL6J_96523 Rbpj-ps1 NCBI_Gene:19665,ENSEMBL:ENSMUSG00000081770 MGI:96523 pseudogene recombination signal binding protein for immunoglobulin kappa J region, pseudogene 1
4 gene 49.375341 49.408151 negative MGI_C57BL6J_2444345 Acnat2 NCBI_Gene:209186,ENSEMBL:ENSMUSG00000060317 MGI:2444345 protein coding gene acyl-coenzyme A amino acid N-acyltransferase 2
4 pseudogene 49.396112 49.410315 positive MGI_C57BL6J_3649963 Gm12451 NCBI_Gene:100418419,ENSEMBL:ENSMUSG00000082725 MGI:3649963 pseudogene predicted gene 12451
4 pseudogene 49.412220 49.412765 positive MGI_C57BL6J_3650619 Gm12452 NCBI_Gene:666617,ENSEMBL:ENSMUSG00000094082 MGI:3650619 pseudogene predicted gene 12452
4 pseudogene 49.430226 49.444084 positive MGI_C57BL6J_96524 Rbpj-ps2 NCBI_Gene:19666 MGI:96524 pseudogene recombination signal binding protein for immunoglobulin kappa J region, pseudogene 2
4 gene 49.443532 49.481318 negative MGI_C57BL6J_2140197 Acnat1 NCBI_Gene:230161,ENSEMBL:ENSMUSG00000070985 MGI:2140197 protein coding gene acyl-coenzyme A amino acid N-acyltransferase 1
4 gene 49.474307 49.474410 positive MGI_C57BL6J_5456201 Gm26424 ENSEMBL:ENSMUSG00000084479 MGI:5456201 snRNA gene predicted gene, 26424
4 gene 49.474707 49.487266 positive MGI_C57BL6J_5592168 Gm33009 NCBI_Gene:102635749 MGI:5592168 lncRNA gene predicted gene, 33009
4 gene 49.478386 49.481036 negative MGI_C57BL6J_1921795 9030417H13Rik NA NA unclassified gene RIKEN cDNA 9030417H13 gene
4 gene 49.488479 49.504473 positive MGI_C57BL6J_5592053 Gm32894 NCBI_Gene:102635603 MGI:5592053 lncRNA gene predicted gene, 32894
4 gene 49.489416 49.507916 negative MGI_C57BL6J_106642 Baat NCBI_Gene:12012,ENSEMBL:ENSMUSG00000039653 MGI:106642 protein coding gene bile acid-Coenzyme A: amino acid N-acyltransferase
4 gene 49.512596 49.521093 negative MGI_C57BL6J_107329 Mrpl50 NCBI_Gene:28028,ENSEMBL:ENSMUSG00000044018 MGI:107329 protein coding gene mitochondrial ribosomal protein L50
4 gene 49.521176 49.531558 positive MGI_C57BL6J_2444707 Zfp189 NCBI_Gene:230162,ENSEMBL:ENSMUSG00000039634 MGI:2444707 protein coding gene zinc finger protein 189
4 gene 49.532184 49.533793 positive MGI_C57BL6J_3026937 1110065F06Rik NA NA unclassified gene RIKEN cDNA 1110065F06 gene
4 gene 49.535993 49.549546 negative MGI_C57BL6J_87995 Aldob NCBI_Gene:230163,ENSEMBL:ENSMUSG00000028307 MGI:87995 protein coding gene aldolase B, fructose-bisphosphate
4 gene 49.584506 49.597876 negative MGI_C57BL6J_1914313 Tmem246 NCBI_Gene:67063,ENSEMBL:ENSMUSG00000039611 MGI:1914313 protein coding gene transmembrane protein 246
4 gene 49.597989 49.599772 positive MGI_C57BL6J_5592265 Gm33106 NCBI_Gene:102635882 MGI:5592265 lncRNA gene predicted gene, 33106
4 gene 49.608027 49.617796 negative MGI_C57BL6J_5592318 Gm33159 NCBI_Gene:102635952 MGI:5592318 lncRNA gene predicted gene, 33159
4 gene 49.630658 49.631946 negative MGI_C57BL6J_5825589 Gm45952 NCBI_Gene:108167345 MGI:5825589 lncRNA gene predicted gene, 45952
4 gene 49.632006 49.656887 positive MGI_C57BL6J_1925927 Rnf20 NCBI_Gene:109331,ENSEMBL:ENSMUSG00000028309 MGI:1925927 protein coding gene ring finger protein 20
4 gene 49.661611 49.845769 negative MGI_C57BL6J_1933206 Grin3a NCBI_Gene:242443,ENSEMBL:ENSMUSG00000039579 MGI:1933206 protein coding gene glutamate receptor ionotropic, NMDA3A
4 gene 49.678747 49.682024 negative MGI_C57BL6J_107171 Ppp3r2 NCBI_Gene:19059,ENSEMBL:ENSMUSG00000028310 MGI:107171 protein coding gene protein phosphatase 3, regulatory subunit B, alpha isoform (calcineurin B, type II)
4 gene 49.682004 49.692792 positive MGI_C57BL6J_5625171 Gm42286 NCBI_Gene:105247131 MGI:5625171 lncRNA gene predicted gene, 42286
4 pseudogene 49.746731 49.747246 negative MGI_C57BL6J_3651071 Gm12459 ENSEMBL:ENSMUSG00000083153 MGI:3651071 pseudogene predicted gene 12459
4 pseudogene 50.050909 50.051403 negative MGI_C57BL6J_3650856 Gm12458 ENSEMBL:ENSMUSG00000081120 MGI:3650856 pseudogene predicted gene 12458
4 gene 50.286746 50.286877 positive MGI_C57BL6J_5455262 Gm25485 ENSEMBL:ENSMUSG00000095394 MGI:5455262 snoRNA gene predicted gene, 25485
4 gene 50.788227 50.827001 negative MGI_C57BL6J_5625173 Gm42288 NCBI_Gene:105247133 MGI:5625173 lncRNA gene predicted gene, 42288
4 gene 50.789624 50.903726 positive MGI_C57BL6J_5625172 Gm42287 NCBI_Gene:105247132 MGI:5625172 lncRNA gene predicted gene, 42287
4 pseudogene 51.190086 51.190463 positive MGI_C57BL6J_3650440 Gm12460 NCBI_Gene:666681,ENSEMBL:ENSMUSG00000084116 MGI:3650440 pseudogene predicted gene 12460
4 gene 51.216670 51.250625 positive MGI_C57BL6J_1922164 Cylc2 NCBI_Gene:74914,ENSEMBL:ENSMUSG00000039555 MGI:1922164 protein coding gene cylicin, basic protein of sperm head cytoskeleton 2
4 pseudogene 51.252470 51.254362 negative MGI_C57BL6J_3650439 Amd-ps4 NCBI_Gene:100040814,ENSEMBL:ENSMUSG00000019836 MGI:3650439 pseudogene S-adenosylmethionine decarboxylase, pseudogene 4
4 gene 51.540747 51.541015 positive MGI_C57BL6J_5452340 Gm22563 ENSEMBL:ENSMUSG00000087958 MGI:5452340 unclassified non-coding RNA gene predicted gene, 22563
4 gene 51.655767 51.655875 positive MGI_C57BL6J_5452820 Gm23043 ENSEMBL:ENSMUSG00000088515 MGI:5452820 snoRNA gene predicted gene, 23043
4 gene 51.799920 51.800352 positive MGI_C57BL6J_5454720 Gm24943 ENSEMBL:ENSMUSG00000088954 MGI:5454720 ribozyme gene predicted gene, 24943
4 gene 51.812483 51.812647 negative MGI_C57BL6J_5451819 Gm22042 ENSEMBL:ENSMUSG00000064923 MGI:5451819 snRNA gene predicted gene, 22042
4 gene 51.876647 51.877430 positive MGI_C57BL6J_5826491 Gm46854 NCBI_Gene:108168942 MGI:5826491 lncRNA gene predicted gene, 46854
4 pseudogene 51.892854 51.894207 positive MGI_C57BL6J_3650438 Gm12461 NCBI_Gene:384015,ENSEMBL:ENSMUSG00000081050 MGI:3650438 pseudogene predicted gene 12461
4 gene 51.968094 52.051110 negative MGI_C57BL6J_3045376 C630028M04Rik NCBI_Gene:329844,ENSEMBL:ENSMUSG00000085515 MGI:3045376 lncRNA gene RIKEN cDNA C630028M04 gene
4 pseudogene 52.077168 52.077467 negative MGI_C57BL6J_3649306 Gm12465 ENSEMBL:ENSMUSG00000082963 MGI:3649306 pseudogene predicted gene 12465
4 pseudogene 52.240866 52.241572 positive MGI_C57BL6J_3651763 Gm12466 NCBI_Gene:100041026,ENSEMBL:ENSMUSG00000083539 MGI:3651763 pseudogene predicted gene 12466
4 pseudogene 52.241712 52.323133 positive MGI_C57BL6J_3651688 Gm12467 NCBI_Gene:100041038,ENSEMBL:ENSMUSG00000082267 MGI:3651688 pseudogene predicted gene 12467
4 pseudogene 52.360823 52.362211 negative MGI_C57BL6J_3649584 Gm12475 NCBI_Gene:666724,ENSEMBL:ENSMUSG00000083338 MGI:3649584 pseudogene predicted gene 12475
4 gene 52.430284 52.438965 negative MGI_C57BL6J_1919898 Smc2os NCBI_Gene:72648,ENSEMBL:ENSMUSG00000085763 MGI:1919898 antisense lncRNA gene structural maintenance of chromosomes 2, opposite strand
4 gene 52.439221 52.488365 positive MGI_C57BL6J_106067 Smc2 NCBI_Gene:14211,ENSEMBL:ENSMUSG00000028312 MGI:106067 protein coding gene structural maintenance of chromosomes 2
4 pseudogene 52.443748 52.445934 negative MGI_C57BL6J_3651628 Tmc4-ps NCBI_Gene:102636091,ENSEMBL:ENSMUSG00000084380 MGI:3651628 pseudogene Tmc4 retrotransposed pseudogene
4 pseudogene 52.494952 52.497319 negative MGI_C57BL6J_3643145 Vma21-ps NCBI_Gene:100040883,ENSEMBL:ENSMUSG00000061619 MGI:3643145 pseudogene VMA21 vacuolar H+-ATPase homolog (S. cerevisiae), pseudogene
4 gene 52.596274 52.612430 positive MGI_C57BL6J_1915524 Toporsl NCBI_Gene:68274,ENSEMBL:ENSMUSG00000028314 MGI:1915524 protein coding gene topoisomerase I binding, arginine/serine-rich like
4 gene 52.615448 52.617881 negative MGI_C57BL6J_5592594 Gm33435 NCBI_Gene:102636342 MGI:5592594 lncRNA gene predicted gene, 33435
4 gene 52.814604 52.828269 positive MGI_C57BL6J_1922617 4930552N02Rik NCBI_Gene:75367 MGI:1922617 lncRNA gene RIKEN cDNA 4930552N02 gene
4 gene 52.814604 52.828269 positive MGI_C57BL6J_3030109 Olfr275 NCBI_Gene:258857,ENSEMBL:ENSMUSG00000089717 MGI:3030109 protein coding gene olfactory receptor 275
4 pseudogene 52.821453 52.822242 positive MGI_C57BL6J_3651627 Gm12482 NCBI_Gene:666761,ENSEMBL:ENSMUSG00000081975 MGI:3651627 pseudogene predicted gene 12482
4 pseudogene 52.842198 52.843046 negative MGI_C57BL6J_3030108 Olfr274-ps1 NCBI_Gene:404368,ENSEMBL:ENSMUSG00000110940 MGI:3030108 pseudogene olfactory receptor 274, pseudogene 1
4 gene 52.852154 52.859236 negative MGI_C57BL6J_3030107 Olfr273 NCBI_Gene:258821,ENSEMBL:ENSMUSG00000049648 MGI:3030107 protein coding gene olfactory receptor 273
4 pseudogene 52.878008 52.878702 positive MGI_C57BL6J_6096954 Gm47786 ENSEMBL:ENSMUSG00000110756 MGI:6096954 pseudogene predicted gene, 47786
4 pseudogene 52.900550 52.902880 positive MGI_C57BL6J_109293 Cct3-ps1 NCBI_Gene:632982,ENSEMBL:ENSMUSG00000083937 MGI:109293 pseudogene chaperonin containing Tcp1, subunit 3 (gamma) pseudogene 1
4 gene 52.910207 52.919178 negative MGI_C57BL6J_3030106 Olfr272 NCBI_Gene:258836,ENSEMBL:ENSMUSG00000051593 MGI:3030106 protein coding gene olfactory receptor 272
4 pseudogene 52.935430 52.936381 negative MGI_C57BL6J_3030105 Olfr271-ps1 NCBI_Gene:258856,ENSEMBL:ENSMUSG00000082216 MGI:3030105 polymorphic pseudogene olfactory receptor 271, pseudogene 1
4 gene 52.944344 52.958773 negative MGI_C57BL6J_5592638 Gm33479 NCBI_Gene:102636404 MGI:5592638 lncRNA gene predicted gene, 33479
4 gene 52.964547 52.972474 positive MGI_C57BL6J_3030104 Olfr270 NCBI_Gene:258600,ENSEMBL:ENSMUSG00000070983 MGI:3030104 protein coding gene olfactory receptor 270
4 gene 52.989272 53.001162 positive MGI_C57BL6J_1920648 Nipsnap3a NCBI_Gene:73398,ENSEMBL:ENSMUSG00000015242 MGI:1920648 protein coding gene nipsnap homolog 3A
4 gene 53.011872 53.022060 positive MGI_C57BL6J_1913786 Nipsnap3b NCBI_Gene:66536,ENSEMBL:ENSMUSG00000015247 MGI:1913786 protein coding gene nipsnap homolog 3B
4 gene 53.030787 53.159988 negative MGI_C57BL6J_99607 Abca1 NCBI_Gene:11303,ENSEMBL:ENSMUSG00000015243 MGI:99607 protein coding gene ATP-binding cassette, sub-family A (ABC1), member 1
4 gene 53.201519 53.220013 negative MGI_C57BL6J_1921191 4930412L05Rik NCBI_Gene:73941,ENSEMBL:ENSMUSG00000087192 MGI:1921191 lncRNA gene RIKEN cDNA 4930412L05 gene
4 gene 53.246196 53.251120 positive MGI_C57BL6J_1925430 4930522O17Rik NCBI_Gene:78180,ENSEMBL:ENSMUSG00000086947 MGI:1925430 lncRNA gene RIKEN cDNA 4930522O17 gene
4 gene 53.261356 53.270232 negative MGI_C57BL6J_2140270 AI427809 NCBI_Gene:381524,ENSEMBL:ENSMUSG00000086712 MGI:2140270 lncRNA gene expressed sequence AI427809
4 pseudogene 53.308226 53.308672 positive MGI_C57BL6J_3650574 Gm12495 ENSEMBL:ENSMUSG00000083735 MGI:3650574 pseudogene predicted gene 12495
4 gene 53.348415 53.404030 negative MGI_C57BL6J_3650573 Gm12496 NCBI_Gene:102636602,ENSEMBL:ENSMUSG00000086267 MGI:3650573 lncRNA gene predicted gene 12496
4 gene 53.438009 53.440685 negative MGI_C57BL6J_5826495 Gm46858 NCBI_Gene:108168953 MGI:5826495 protein coding gene predicted gene, 46858
4 gene 53.440413 53.622478 positive MGI_C57BL6J_2140592 Slc44a1 NCBI_Gene:100434,ENSEMBL:ENSMUSG00000028412 MGI:2140592 protein coding gene solute carrier family 44, member 1
4 gene 53.562983 53.564697 negative MGI_C57BL6J_1920641 1700060J05Rik ENSEMBL:ENSMUSG00000084970 MGI:1920641 lncRNA gene RIKEN cDNA 1700060J05 gene
4 gene 53.572440 53.573034 positive MGI_C57BL6J_1924958 9130223C08Rik NA NA unclassified gene RIKEN cDNA 9130223C08 gene
4 gene 53.583196 53.629872 negative MGI_C57BL6J_5592888 Gm33729 NCBI_Gene:102636739 MGI:5592888 lncRNA gene predicted gene, 33729
4 gene 53.629927 53.707009 positive MGI_C57BL6J_2442443 Fsd1l NCBI_Gene:319636,ENSEMBL:ENSMUSG00000054752 MGI:2442443 protein coding gene fibronectin type III and SPRY domain containing 1-like
4 pseudogene 53.662296 53.663344 positive MGI_C57BL6J_3652113 Gm12470 NCBI_Gene:100534358,ENSEMBL:ENSMUSG00000081516 MGI:3652113 pseudogene predicted gene 12470
4 gene 53.712729 53.777890 positive MGI_C57BL6J_2179507 Fktn NCBI_Gene:246179,ENSEMBL:ENSMUSG00000028414 MGI:2179507 protein coding gene fukutin
4 gene 53.720902 53.721200 negative MGI_C57BL6J_5455222 Gm25445 ENSEMBL:ENSMUSG00000089621 MGI:5455222 unclassified non-coding RNA gene predicted gene, 25445
4 gene 53.779705 53.788712 positive MGI_C57BL6J_99540 Tal2 NCBI_Gene:21350,ENSEMBL:ENSMUSG00000028417 MGI:99540 protein coding gene T cell acute lymphocytic leukemia 2
4 pseudogene 53.791031 53.791468 negative MGI_C57BL6J_3652112 Rps15a-ps8 NCBI_Gene:435784,ENSEMBL:ENSMUSG00000084403 MGI:3652112 pseudogene ribosomal protein S15A, pseudogene 8
4 gene 53.826045 53.862019 positive MGI_C57BL6J_1098718 Tmem38b NCBI_Gene:52076,ENSEMBL:ENSMUSG00000028420 MGI:1098718 protein coding gene transmembrane protein 38B
4 gene 53.860652 53.860770 positive MGI_C57BL6J_4422050 n-R5s185 ENSEMBL:ENSMUSG00000065887 MGI:4422050 rRNA gene nuclear encoded rRNA 5S 185
4 pseudogene 53.876587 53.878430 positive MGI_C57BL6J_3652115 Gm12468 NCBI_Gene:670124,ENSEMBL:ENSMUSG00000083985 MGI:3652115 pseudogene predicted gene 12468
4 gene 53.905696 53.905820 positive MGI_C57BL6J_5453522 Gm23745 ENSEMBL:ENSMUSG00000077418 MGI:5453522 snoRNA gene predicted gene, 23745
4 gene 53.948265 53.951306 negative MGI_C57BL6J_5592999 Gm33840 NCBI_Gene:102636891 MGI:5592999 lncRNA gene predicted gene, 33840
4 gene 54.004057 54.004187 positive MGI_C57BL6J_5453954 Gm24177 ENSEMBL:ENSMUSG00000089552 MGI:5453954 snoRNA gene predicted gene, 24177
4 gene 54.029718 54.070691 positive MGI_C57BL6J_5593052 Gm33893 NCBI_Gene:102636969 MGI:5593052 lncRNA gene predicted gene, 33893
4 gene 54.151831 54.163678 negative MGI_C57BL6J_3651626 Gm12484 ENSEMBL:ENSMUSG00000086987 MGI:3651626 lncRNA gene predicted gene 12484
4 gene 54.183218 54.191833 positive MGI_C57BL6J_5593167 Gm34008 NCBI_Gene:102637114 MGI:5593167 lncRNA gene predicted gene, 34008
4 pseudogene 54.235670 54.235876 negative MGI_C57BL6J_3652114 Gm12469 ENSEMBL:ENSMUSG00000083624 MGI:3652114 pseudogene predicted gene 12469
4 gene 54.468352 54.468592 positive MGI_C57BL6J_5455464 Gm25687 ENSEMBL:ENSMUSG00000093183 MGI:5455464 unclassified non-coding RNA gene predicted gene, 25687
4 gene 54.550320 54.551475 negative MGI_C57BL6J_5593231 Gm34072 NCBI_Gene:102637198 MGI:5593231 lncRNA gene predicted gene, 34072
4 pseudogene 54.564566 54.565337 positive MGI_C57BL6J_2664996 Tpt1-ps2 NCBI_Gene:666901,ENSEMBL:ENSMUSG00000081428 MGI:2664996 pseudogene tumor protein, translationally-controlled, pseudogene 2
4 gene 54.645811 54.646280 negative MGI_C57BL6J_5579773 Gm29067 ENSEMBL:ENSMUSG00000099421 MGI:5579773 lncRNA gene predicted gene 29067
4 gene 54.646542 54.689451 positive MGI_C57BL6J_3651221 Gm12478 ENSEMBL:ENSMUSG00000086371 MGI:3651221 lncRNA gene predicted gene 12478
4 gene 54.651903 54.656077 positive MGI_C57BL6J_3651952 Gm12480 ENSEMBL:ENSMUSG00000087077 MGI:3651952 lncRNA gene predicted gene 12480
4 pseudogene 54.669620 54.670192 negative MGI_C57BL6J_3651220 Gm12477 NCBI_Gene:100416401,ENSEMBL:ENSMUSG00000083868 MGI:3651220 pseudogene predicted gene 12477
4 gene 54.710624 54.710912 positive MGI_C57BL6J_5454405 Gm24628 ENSEMBL:ENSMUSG00000084710 MGI:5454405 unclassified non-coding RNA gene predicted gene, 24628
4 gene 54.851245 54.893939 negative MGI_C57BL6J_5593292 Gm34133 NCBI_Gene:102637273 MGI:5593292 lncRNA gene predicted gene, 34133
4 pseudogene 54.852489 54.854712 positive MGI_C57BL6J_3651218 Gm12479 NCBI_Gene:384018,ENSEMBL:ENSMUSG00000082111 MGI:3651218 pseudogene predicted gene 12479
4 gene 54.943861 55.083563 positive MGI_C57BL6J_107690 Zfp462 NCBI_Gene:242466,ENSEMBL:ENSMUSG00000060206 MGI:107690 protein coding gene zinc finger protein 462
4 gene 54.944474 54.947939 negative MGI_C57BL6J_5826496 Gm46859 NCBI_Gene:108168957 MGI:5826496 lncRNA gene predicted gene, 46859
4 gene 54.944486 54.945856 negative MGI_C57BL6J_3645200 Gm8364 NA NA unclassified gene predicted gene 8364
4 gene 55.020910 55.021273 positive MGI_C57BL6J_1924603 9430095M17Rik NA NA unclassified gene RIKEN cDNA 9430095M17 gene
4 gene 55.043188 55.044815 negative MGI_C57BL6J_3641952 Gm10588 NA NA unclassified gene predicted gene 10588
4 gene 55.060520 55.069271 negative MGI_C57BL6J_5625174 Gm42289 NCBI_Gene:105247134 MGI:5625174 lncRNA gene predicted gene, 42289
4 pseudogene 55.116563 55.116923 positive MGI_C57BL6J_3651354 Gm12515 ENSEMBL:ENSMUSG00000082704 MGI:3651354 pseudogene predicted gene 12515
4 gene 55.129708 55.279479 negative MGI_C57BL6J_3651364 Gm12514 NCBI_Gene:105247135,ENSEMBL:ENSMUSG00000087614 MGI:3651364 lncRNA gene predicted gene 12514
4 pseudogene 55.163008 55.163616 positive MGI_C57BL6J_3651361 Gm12509 NCBI_Gene:100417778,ENSEMBL:ENSMUSG00000081177 MGI:3651361 pseudogene predicted gene 12509
4 gene 55.207862 55.238936 positive MGI_C57BL6J_5593390 Gm34231 NCBI_Gene:102637421 MGI:5593390 lncRNA gene predicted gene, 34231
4 pseudogene 55.243673 55.255219 positive MGI_C57BL6J_3651359 Gm12508 NCBI_Gene:670211,ENSEMBL:ENSMUSG00000081504 MGI:3651359 pseudogene predicted gene 12508
4 pseudogene 55.282064 55.282607 negative MGI_C57BL6J_3651362 Gm12512 NCBI_Gene:108168954,ENSEMBL:ENSMUSG00000081542 MGI:3651362 pseudogene predicted gene 12512
4 gene 55.291571 55.291813 positive MGI_C57BL6J_1918945 0910001E24Rik NA NA unclassified gene RIKEN cDNA 0910001E24 gene
4 gene 55.299655 55.299845 negative MGI_C57BL6J_5455196 Gm25419 ENSEMBL:ENSMUSG00000077403 MGI:5455196 snoRNA gene predicted gene, 25419
4 gene 55.341228 55.349619 negative MGI_C57BL6J_5625175 Gm42290 NCBI_Gene:105247136 MGI:5625175 lncRNA gene predicted gene, 42290
4 gene 55.350042 55.392237 positive MGI_C57BL6J_105128 Rad23b NCBI_Gene:19359,ENSEMBL:ENSMUSG00000028426 MGI:105128 protein coding gene RAD23 homolog B, nucleotide excision repair protein
4 pseudogene 55.392270 55.392923 negative MGI_C57BL6J_3651353 Gm12516 NCBI_Gene:108168955,ENSEMBL:ENSMUSG00000084144 MGI:3651353 pseudogene predicted gene 12516
4 gene 55.393796 55.399385 negative MGI_C57BL6J_5593449 Gm34290 NCBI_Gene:102637498 MGI:5593449 lncRNA gene predicted gene, 34290
4 pseudogene 55.408956 55.409307 negative MGI_C57BL6J_3649753 Gm12513 ENSEMBL:ENSMUSG00000084404 MGI:3649753 pseudogene predicted gene 12513
4 gene 55.410443 55.418842 negative MGI_C57BL6J_3651173 Gm12505 NCBI_Gene:100415914,ENSEMBL:ENSMUSG00000087070 MGI:3651173 lncRNA gene predicted gene 12505
4 gene 55.450684 55.465814 negative MGI_C57BL6J_3651360 Gm12510 ENSEMBL:ENSMUSG00000086346 MGI:3651360 lncRNA gene predicted gene 12510
4 gene 55.469025 55.469159 negative MGI_C57BL6J_5451927 Gm22150 ENSEMBL:ENSMUSG00000077635 MGI:5451927 snoRNA gene predicted gene, 22150
4 pseudogene 55.508294 55.508708 positive MGI_C57BL6J_3651171 Gm12507 ENSEMBL:ENSMUSG00000082952 MGI:3651171 pseudogene predicted gene 12507
4 gene 55.527137 55.532475 negative MGI_C57BL6J_1342287 Klf4 NCBI_Gene:16600,ENSEMBL:ENSMUSG00000003032 MGI:1342287 protein coding gene Kruppel-like factor 4 (gut)
4 gene 55.532867 55.639189 positive MGI_C57BL6J_3651170 Gm12506 NCBI_Gene:102637640,ENSEMBL:ENSMUSG00000085375 MGI:3651170 lncRNA gene predicted gene 12506
4 gene 55.538879 55.541743 positive MGI_C57BL6J_5593502 Gm34343 NCBI_Gene:102637567 MGI:5593502 lncRNA gene predicted gene, 34343
4 gene 55.563265 55.599296 positive MGI_C57BL6J_3651363 Gm12511 NCBI_Gene:791419,ENSEMBL:ENSMUSG00000066176 MGI:3651363 lncRNA gene predicted gene 12511
4 gene 55.948000 55.953411 negative MGI_C57BL6J_5593641 Gm34482 NCBI_Gene:102637751 MGI:5593641 lncRNA gene predicted gene, 34482
4 gene 55.966541 56.000822 negative MGI_C57BL6J_3652272 Gm12519 NCBI_Gene:102637828,ENSEMBL:ENSMUSG00000085643 MGI:3652272 lncRNA gene predicted gene 12519
4 pseudogene 56.162940 56.163255 positive MGI_C57BL6J_3652271 Gm12520 ENSEMBL:ENSMUSG00000081290 MGI:3652271 pseudogene predicted gene 12520
4 gene 56.220617 56.224521 negative MGI_C57BL6J_1919656 2310081O03Rik ENSEMBL:ENSMUSG00000085020 MGI:1919656 lncRNA gene RIKEN cDNA 2310081O03 gene
4 gene 56.267323 56.315967 negative MGI_C57BL6J_5625176 Gm42291 NCBI_Gene:105247137 MGI:5625176 lncRNA gene predicted gene, 42291
4 pseudogene 56.387802 56.388580 positive MGI_C57BL6J_3652273 Gm12518 NCBI_Gene:100416258,ENSEMBL:ENSMUSG00000082613 MGI:3652273 pseudogene predicted gene 12518
4 gene 56.455912 56.478396 negative MGI_C57BL6J_5593787 Gm34628 NCBI_Gene:102637940 MGI:5593787 lncRNA gene predicted gene, 34628
4 gene 56.622955 56.714425 negative MGI_C57BL6J_5593846 Gm34687 NCBI_Gene:102638019 MGI:5593846 lncRNA gene predicted gene, 34687
4 gene 56.678904 56.679035 negative MGI_C57BL6J_5455921 Gm26144 ENSEMBL:ENSMUSG00000077663 MGI:5455921 snoRNA gene predicted gene, 26144
4 gene 56.740005 56.741443 negative MGI_C57BL6J_1343053 Actl7b NCBI_Gene:11471,ENSEMBL:ENSMUSG00000070980 MGI:1343053 protein coding gene actin-like 7b
4 gene 56.740070 56.741377 positive MGI_C57BL6J_5477151 Gm26657 ENSEMBL:ENSMUSG00000096930 MGI:5477151 protein coding gene predicted gene, 26657
4 gene 56.743413 56.744925 positive MGI_C57BL6J_1343051 Actl7a NCBI_Gene:11470,ENSEMBL:ENSMUSG00000070979 MGI:1343051 protein coding gene actin-like 7a
4 gene 56.749680 56.802331 negative MGI_C57BL6J_1914544 Elp1 NCBI_Gene:230233,ENSEMBL:ENSMUSG00000028431 MGI:1914544 protein coding gene elongator complex protein 1
4 gene 56.761922 56.762041 negative MGI_C57BL6J_5452729 Gm22952 ENSEMBL:ENSMUSG00000080370 MGI:5452729 snoRNA gene predicted gene, 22952
4 gene 56.802329 56.809605 positive MGI_C57BL6J_2677850 Abitram NCBI_Gene:230234,ENSEMBL:ENSMUSG00000038827 MGI:2677850 protein coding gene actin binding transcription modulator
4 gene 56.810935 56.865379 negative MGI_C57BL6J_1859649 Ctnnal1 NCBI_Gene:54366,ENSEMBL:ENSMUSG00000038816 MGI:1859649 protein coding gene catenin (cadherin associated protein), alpha-like 1
4 gene 56.866923 56.947565 negative MGI_C57BL6J_2445107 Tmem245 NCBI_Gene:242474,ENSEMBL:ENSMUSG00000055296 MGI:2445107 protein coding gene transmembrane protein 245
4 gene 56.895229 56.895298 negative MGI_C57BL6J_3619331 Mir32 miRBase:MI0000691,NCBI_Gene:723837,ENSEMBL:ENSMUSG00000065544 MGI:3619331 miRNA gene microRNA 32
4 gene 56.897625 56.897757 negative MGI_C57BL6J_5454830 Gm25053 ENSEMBL:ENSMUSG00000106585,ENSEMBL:ENSMUSG00000099002 MGI:5454830 snoRNA gene predicted gene, 25053
4 gene 56.913642 56.913767 positive MGI_C57BL6J_5452077 Gm22300 ENSEMBL:ENSMUSG00000064595 MGI:5452077 snoRNA gene predicted gene, 22300
4 gene 56.957173 56.957872 positive MGI_C57BL6J_2140381 9630041G16Rik NA NA unclassified gene RIKEN cDNA 9630041G16 gene
4 gene 56.957173 56.990391 negative MGI_C57BL6J_2442704 Frrs1l NCBI_Gene:230235,ENSEMBL:ENSMUSG00000045589 MGI:2442704 protein coding gene ferric-chelate reductase 1 like
4 gene 56.991972 57.143437 negative MGI_C57BL6J_1859149 Epb41l4b NCBI_Gene:54357,ENSEMBL:ENSMUSG00000028434 MGI:1859149 protein coding gene erythrocyte membrane protein band 4.1 like 4b
4 gene 57.052753 57.054106 positive MGI_C57BL6J_5593897 Gm34738 NCBI_Gene:102638093 MGI:5593897 lncRNA gene predicted gene, 34738
4 gene 57.160663 57.164154 positive MGI_C57BL6J_5593961 Gm34802 NCBI_Gene:102638176 MGI:5593961 lncRNA gene predicted gene, 34802
4 gene 57.172071 57.176554 positive MGI_C57BL6J_3651546 Gm12530 NCBI_Gene:329851,ENSEMBL:ENSMUSG00000085967 MGI:3651546 lncRNA gene predicted gene 12530
4 gene 57.190841 57.339040 negative MGI_C57BL6J_105307 Ptpn3 NCBI_Gene:545622,ENSEMBL:ENSMUSG00000038764 MGI:105307 protein coding gene protein tyrosine phosphatase, non-receptor type 3
4 gene 57.299793 57.308587 positive MGI_C57BL6J_3650719 Gm12536 NCBI_Gene:102638251,ENSEMBL:ENSMUSG00000085654 MGI:3650719 lncRNA gene predicted gene 12536
4 gene 57.359792 57.364292 negative MGI_C57BL6J_1920599 1700042G15Rik NCBI_Gene:73349,ENSEMBL:ENSMUSG00000087044 MGI:1920599 lncRNA gene RIKEN cDNA 1700042G15 gene
4 pseudogene 57.370772 57.371972 negative MGI_C57BL6J_3650720 Gm12537 NCBI_Gene:100041342,ENSEMBL:ENSMUSG00000095042 MGI:3650720 pseudogene predicted gene 12537
4 pseudogene 57.413671 57.414269 negative MGI_C57BL6J_3650715 Gm12538 NCBI_Gene:619973,ENSEMBL:ENSMUSG00000081540 MGI:3650715 pseudogene predicted gene 12538
4 gene 57.434247 57.896984 positive MGI_C57BL6J_5141924 Pakap NCBI_Gene:677884,NCBI_Gene:11641,NCBI_Gene:242481,ENSEMBL:ENSMUSG00000038729,ENSEMBL:ENSMUSG00000089945,ENSEMBL:ENSMUSG00000090053 MGI:5141924 protein coding gene paralemmin A kinase anchor protein
4 pseudogene 57.453657 57.457595 negative MGI_C57BL6J_3650716 Gm12539 NCBI_Gene:667049,ENSEMBL:ENSMUSG00000081615 MGI:3650716 pseudogene predicted gene 12539
4 gene 57.611535 57.611872 positive MGI_C57BL6J_1919814 2700063P09Rik NA NA unclassified gene RIKEN cDNA 2700063P09 gene
4 gene 57.727766 57.730420 negative MGI_C57BL6J_1924878 4930544N03Rik NA NA unclassified gene RIKEN cDNA 4930544N03 gene
4 gene 57.730081 57.756022 negative MGI_C57BL6J_5594258 Gm35099 NCBI_Gene:102638565 MGI:5594258 lncRNA gene predicted gene, 35099
4 gene 57.757739 57.763901 negative MGI_C57BL6J_3651778 Gm12526 ENSEMBL:ENSMUSG00000073846 MGI:3651778 lncRNA gene predicted gene 12526
4 gene 57.762607 57.762710 positive MGI_C57BL6J_5454054 Gm24277 ENSEMBL:ENSMUSG00000089286 MGI:5454054 snRNA gene predicted gene, 24277
4 gene 57.877389 57.877495 negative MGI_C57BL6J_5455915 Gm26138 ENSEMBL:ENSMUSG00000096195 MGI:5455915 snRNA gene predicted gene, 26138
4 gene 57.908384 57.916297 negative MGI_C57BL6J_2442889 D630039A03Rik NCBI_Gene:242484,ENSEMBL:ENSMUSG00000052117 MGI:2442889 protein coding gene RIKEN cDNA D630039A03 gene
4 gene 57.916639 57.918420 positive MGI_C57BL6J_5625178 Gm42293 NCBI_Gene:105247139 MGI:5625178 lncRNA gene predicted gene, 42293
4 gene 57.921421 57.923431 negative MGI_C57BL6J_5625177 Gm42292 NCBI_Gene:105247138 MGI:5625177 lncRNA gene predicted gene, 42292
4 gene 57.943373 57.956411 negative MGI_C57BL6J_98874 Txn1 NCBI_Gene:22166,ENSEMBL:ENSMUSG00000028367 MGI:98874 protein coding gene thioredoxin 1
4 gene 57.956508 57.968149 positive MGI_C57BL6J_5594503 Gm35344 NCBI_Gene:102638892 MGI:5594503 lncRNA gene predicted gene, 35344
4 gene 57.984021 58.009135 negative MGI_C57BL6J_1914652 Txndc8 NCBI_Gene:67402,ENSEMBL:ENSMUSG00000038709 MGI:1914652 protein coding gene thioredoxin domain containing 8
4 gene 58.034506 58.065819 positive MGI_C57BL6J_5594561 Gm35402 NCBI_Gene:102638969 MGI:5594561 lncRNA gene predicted gene, 35402
4 gene 58.042442 58.206859 negative MGI_C57BL6J_1928849 Svep1 NCBI_Gene:64817,ENSEMBL:ENSMUSG00000028369 MGI:1928849 protein coding gene sushi, von Willebrand factor type A, EGF and pentraxin domain containing 1
4 gene 58.178247 58.206635 positive MGI_C57BL6J_5477383 Gm26889 ENSEMBL:ENSMUSG00000097249 MGI:5477383 lncRNA gene predicted gene, 26889
4 pseudogene 58.268019 58.268196 negative MGI_C57BL6J_5590066 Gm30907 NCBI_Gene:102632965 MGI:5590066 pseudogene predicted gene, 30907
4 gene 58.285725 58.377848 positive MGI_C57BL6J_103581 Musk NCBI_Gene:18198,ENSEMBL:ENSMUSG00000057280 MGI:103581 protein coding gene muscle, skeletal, receptor tyrosine kinase
4 gene 58.435252 58.554027 negative MGI_C57BL6J_108429 Lpar1 NCBI_Gene:14745,ENSEMBL:ENSMUSG00000038668 MGI:108429 protein coding gene lysophosphatidic acid receptor 1
4 gene 58.441012 58.441098 negative MGI_C57BL6J_4834310 Mir3095 miRBase:MI0014088,NCBI_Gene:100526502,ENSEMBL:ENSMUSG00000093293 MGI:4834310 miRNA gene microRNA 3095
4 pseudogene 58.482736 58.483825 negative MGI_C57BL6J_3651713 Gm12577 NCBI_Gene:100417556,ENSEMBL:ENSMUSG00000083834 MGI:3651713 pseudogene predicted gene 12577
4 pseudogene 58.589764 58.590180 positive MGI_C57BL6J_3651712 Gm12578 ENSEMBL:ENSMUSG00000081186 MGI:3651712 pseudogene predicted gene 12578
4 pseudogene 58.611058 58.611857 positive MGI_C57BL6J_3651711 Gm12579 NCBI_Gene:675306,ENSEMBL:ENSMUSG00000083145 MGI:3651711 pseudogene predicted gene 12579
4 gene 58.648392 58.658592 negative MGI_C57BL6J_3651872 Gm12580 ENSEMBL:ENSMUSG00000086470 MGI:3651872 lncRNA gene predicted gene 12580
4 gene 58.782704 58.787716 negative MGI_C57BL6J_3030101 Olfr267 NCBI_Gene:258922,ENSEMBL:ENSMUSG00000043385 MGI:3030101 protein coding gene olfactory receptor 267
4 gene 58.797234 58.913110 negative MGI_C57BL6J_2140220 Ecpas NCBI_Gene:230249,ENSEMBL:ENSMUSG00000050812 MGI:2140220 protein coding gene Ecm29 proteasome adaptor and scaffold
4 gene 58.938025 58.938109 positive MGI_C57BL6J_5456177 Gm26400 ENSEMBL:ENSMUSG00000092753 MGI:5456177 rRNA gene predicted gene, 26400
4 gene 58.943568 58.962624 positive MGI_C57BL6J_3510405 Zkscan16 NCBI_Gene:100041581,ENSEMBL:ENSMUSG00000038630 MGI:3510405 protein coding gene zinc finger with KRAB and SCAN domains 16
4 gene 58.965439 58.987131 negative MGI_C57BL6J_1914353 Ptgr1 NCBI_Gene:67103,ENSEMBL:ENSMUSG00000028378 MGI:1914353 protein coding gene prostaglandin reductase 1
4 gene 58.994800 59.025573 positive MGI_C57BL6J_1919679 Dnajc25 NCBI_Gene:72429,ENSEMBL:ENSMUSG00000070972 MGI:1919679 protein coding gene DnaJ heat shock protein family (Hsp40) member C25
4 gene 59.002338 59.003075 negative MGI_C57BL6J_1921126 4930432F03Rik NA NA unclassified gene RIKEN cDNA 4930432F03 gene
4 gene 59.003210 59.041888 positive MGI_C57BL6J_5141968 Gm20503 ENSEMBL:ENSMUSG00000092345 MGI:5141968 protein coding gene predicted gene 20503
4 gene 59.035088 59.041903 positive MGI_C57BL6J_1336169 Gng10 NCBI_Gene:14700,ENSEMBL:ENSMUSG00000038607 MGI:1336169 protein coding gene guanine nucleotide binding protein (G protein), gamma 10
4 gene 59.041984 59.138983 negative MGI_C57BL6J_2140313 Shoc1 NCBI_Gene:100155,ENSEMBL:ENSMUSG00000038598 MGI:2140313 protein coding gene shortage in chiasmata 1
4 pseudogene 59.090187 59.090929 positive MGI_C57BL6J_3649249 Gm12593 ENSEMBL:ENSMUSG00000081432 MGI:3649249 pseudogene predicted gene 12593
4 gene 59.117970 59.135814 positive MGI_C57BL6J_5594686 Gm35527 NCBI_Gene:102639146 MGI:5594686 lncRNA gene predicted gene, 35527
4 gene 59.135068 59.137454 negative MGI_C57BL6J_3649447 Gm12594 ENSEMBL:ENSMUSG00000086660 MGI:3649447 lncRNA gene predicted gene 12594
4 pseudogene 59.162203 59.163233 negative MGI_C57BL6J_3649246 Rpsa-ps11 NCBI_Gene:433712,ENSEMBL:ENSMUSG00000082978 MGI:3649246 pseudogene ribosomal protein SA, pseudogene 11
4 gene 59.189170 59.222833 positive MGI_C57BL6J_1332243 Ugcg NCBI_Gene:22234,ENSEMBL:ENSMUSG00000028381 MGI:1332243 protein coding gene UDP-glucose ceramide glucosyltransferase
4 gene 59.260051 59.269144 positive MGI_C57BL6J_3649247 Gm12596 NCBI_Gene:101055769,ENSEMBL:ENSMUSG00000086952 MGI:3649247 lncRNA gene predicted gene 12596
4 gene 59.269203 59.281709 negative MGI_C57BL6J_5594737 Gm35578 NCBI_Gene:102639218 MGI:5594737 lncRNA gene predicted gene, 35578
4 gene 59.314202 59.439293 negative MGI_C57BL6J_3651543 Susd1 NCBI_Gene:634731,ENSEMBL:ENSMUSG00000038578 MGI:3651543 protein coding gene sushi domain containing 1
4 pseudogene 59.368106 59.368866 negative MGI_C57BL6J_3651542 Gm12527 NCBI_Gene:666719,ENSEMBL:ENSMUSG00000083979 MGI:3651542 pseudogene predicted gene 12527
4 gene 59.471868 59.549377 negative MGI_C57BL6J_1923334 Ptbp3 NCBI_Gene:230257,ENSEMBL:ENSMUSG00000028382 MGI:1923334 protein coding gene polypyrimidine tract binding protein 3
4 pseudogene 59.532747 59.533014 positive MGI_C57BL6J_3651544 Gm12529 ENSEMBL:ENSMUSG00000080831 MGI:3651544 pseudogene predicted gene 12529
4 pseudogene 59.549154 59.549625 positive MGI_C57BL6J_1919495 1700018M17Rik ENSEMBL:ENSMUSG00000046145 MGI:1919495 pseudogene RIKEN cDNA 1700018M17 gene
4 gene 59.581326 59.618694 positive MGI_C57BL6J_1919729 Hsdl2 NCBI_Gene:72479,ENSEMBL:ENSMUSG00000028383 MGI:1919729 protein coding gene hydroxysteroid dehydrogenase like 2
4 gene 59.626200 59.761439 positive MGI_C57BL6J_2442164 E130308A19Rik NCBI_Gene:230259,ENSEMBL:ENSMUSG00000045071 MGI:2442164 protein coding gene RIKEN cDNA E130308A19 gene
4 gene 59.769124 59.769391 negative MGI_C57BL6J_1919846 2700054B07Rik NA NA unclassified gene RIKEN cDNA 2700054B07 gene
4 gene 59.769637 59.801589 negative MGI_C57BL6J_1913459 Inip NCBI_Gene:66209,ENSEMBL:ENSMUSG00000038544 MGI:1913459 protein coding gene INTS3 and NABP interacting protein
4 gene 59.805126 59.904740 positive MGI_C57BL6J_2443882 Snx30 NCBI_Gene:209131,ENSEMBL:ENSMUSG00000028385 MGI:2443882 protein coding gene sorting nexin family member 30
4 pseudogene 59.833674 59.834219 positive MGI_C57BL6J_3649591 Gm12543 NCBI_Gene:100416087,ENSEMBL:ENSMUSG00000080772 MGI:3649591 pseudogene predicted gene 12543
4 gene 59.889986 59.894924 negative MGI_C57BL6J_3651424 Gm12542 ENSEMBL:ENSMUSG00000073843 MGI:3651424 lncRNA gene predicted gene 12542
4 gene 59.905126 59.915056 negative MGI_C57BL6J_1353616 Slc46a2 NCBI_Gene:30936,ENSEMBL:ENSMUSG00000028386 MGI:1353616 protein coding gene solute carrier family 46, member 2
4 gene 59.956804 59.960710 negative MGI_C57BL6J_97236 Mup4 NCBI_Gene:17843,ENSEMBL:ENSMUSG00000041333 MGI:97236 protein coding gene major urinary protein 4
4 gene 59.964294 60.007274 positive MGI_C57BL6J_3650962 Mup6 NCBI_Gene:620807,ENSEMBL:ENSMUSG00000078689 MGI:3650962 protein coding gene major urinary protein 6
4 pseudogene 60.041309 60.106843 positive MGI_C57BL6J_3651069 Mup-ps1 NCBI_Gene:100417331,ENSEMBL:ENSMUSG00000083239 MGI:3651069 pseudogene major urinary protein, pseudogene 1
4 gene 60.066469 60.070481 negative MGI_C57BL6J_3709615 Mup7 NCBI_Gene:100041658,ENSEMBL:ENSMUSG00000073842 MGI:3709615 protein coding gene major urinary protein 7
4 gene 60.135913 60.154289 negative MGI_C57BL6J_97234 Mup2 NCBI_Gene:17841,ENSEMBL:ENSMUSG00000078688 MGI:97234 protein coding gene major urinary protein 2
4 pseudogene 60.140754 60.159496 positive MGI_C57BL6J_3651073 Mup-ps2 NCBI_Gene:620882,ENSEMBL:ENSMUSG00000073840 MGI:3651073 pseudogene major urinary protein, pseudogene 2
4 gene 60.218620 60.222599 negative MGI_C57BL6J_3709619 Mup8 NCBI_Gene:100041687,ENSEMBL:ENSMUSG00000078687 MGI:3709619 protein coding gene major urinary protein 8
4 pseudogene 60.237345 60.244889 positive MGI_C57BL6J_3650796 Mup-ps3 NCBI_Gene:102639433,ENSEMBL:ENSMUSG00000095455 MGI:3650796 pseudogene major urinary protein, pseudogene 3
4 pseudogene 60.384494 60.384695 positive MGI_C57BL6J_3783596 Mup-ps29 ENSEMBL:ENSMUSG00000096654 MGI:3783596 pseudogene major urinary protein, pseudogene 29
4 pseudogene 60.389861 60.390149 positive MGI_C57BL6J_3782925 Mup-ps28 ENSEMBL:ENSMUSG00000083293 MGI:3782925 pseudogene major urinary protein, pseudogene 28
4 gene 60.418046 60.421961 negative MGI_C57BL6J_3782918 Mup9 NCBI_Gene:100038948,ENSEMBL:ENSMUSG00000078686 MGI:3782918 protein coding gene major urinary protein 9
4 pseudogene 60.437361 60.440064 positive MGI_C57BL6J_3782916 Mup-ps4 NCBI_Gene:620997,ENSEMBL:ENSMUSG00000078685 MGI:3782916 pseudogene major urinary protein, pseudogene 4
4 pseudogene 60.479408 60.479609 positive MGI_C57BL6J_3705793 Mup-ps26 ENSEMBL:ENSMUSG00000094202 MGI:3705793 pseudogene major urinary protein, pseudogene 26
4 gene 60.498012 60.501960 negative MGI_C57BL6J_97233 Mup1 NCBI_Gene:17840,ENSEMBL:ENSMUSG00000078683 MGI:97233 protein coding gene major urinary protein 1
4 gene 60.502841 60.521228 positive MGI_C57BL6J_3712316 Gm13773 NCBI_Gene:102639616,ENSEMBL:ENSMUSG00000086253 MGI:3712316 lncRNA gene predicted gene 13773
4 pseudogene 60.517461 60.520175 positive MGI_C57BL6J_3647161 Mup-ps6 ENSEMBL:ENSMUSG00000094222 MGI:3647161 pseudogene major urinary protein, pseudogene 6
4 pseudogene 60.557570 60.557855 positive MGI_C57BL6J_3650405 Mup-ps24 ENSEMBL:ENSMUSG00000094235 MGI:3650405 pseudogene major urinary protein, pseudogene 24
4 gene 60.578260 60.582199 negative MGI_C57BL6J_1924164 Mup10 NCBI_Gene:100039008,ENSEMBL:ENSMUSG00000078680 MGI:1924164 protein coding gene major urinary protein 10
4 pseudogene 60.597597 60.597695 positive MGI_C57BL6J_3650601 Mup-ps5 ENSEMBL:ENSMUSG00000082868 MGI:3650601 pseudogene major urinary protein, pseudogene 5
4 gene 60.658466 60.662411 negative MGI_C57BL6J_3709617 Mup11 NCBI_Gene:100039028,ENSEMBL:ENSMUSG00000073834 MGI:3709617 protein coding gene major urinary protein 11
4 pseudogene 60.677681 60.681479 positive MGI_C57BL6J_3651245 Mup-ps7 NCBI_Gene:620982,ENSEMBL:ENSMUSG00000094743 MGI:3651245 pseudogene major urinary protein, pseudogene 7
4 gene 60.737381 60.741326 negative MGI_C57BL6J_3780193 Mup12 NCBI_Gene:100039054,ENSEMBL:ENSMUSG00000094793 MGI:3780193 protein coding gene major urinary protein 12
4 pseudogene 60.742389 60.760579 positive MGI_C57BL6J_3780197 Mup-ps8 NCBI_Gene:100039063,ENSEMBL:ENSMUSG00000096891 MGI:3780197 pseudogene major urinary protein, pseudogene 8
4 gene 60.817586 60.821590 negative MGI_C57BL6J_5434675 Mup22 NCBI_Gene:100861909,ENSEMBL:ENSMUSG00000110439 MGI:5434675 protein coding gene major urinary protein 22
4 pseudogene 60.836908 60.840554 positive MGI_C57BL6J_5434641 Gm21286 NCBI_Gene:102640145,ENSEMBL:ENSMUSG00000094948 MGI:5434641 pseudogene predicted gene, 21286
4 pseudogene 61.163063 61.166704 positive MGI_C57BL6J_3649622 Mup-ps9 NCBI_Gene:667234,ENSEMBL:ENSMUSG00000096652 MGI:3649622 pseudogene major urinary protein, pseudogene 9
4 gene 61.224307 61.228286 negative MGI_C57BL6J_3702003 Mup13 NCBI_Gene:100039089,ENSEMBL:ENSMUSG00000089873 MGI:3702003 protein coding gene major urinary protein 13
4 pseudogene 61.229086 61.247342 positive MGI_C57BL6J_3649623 Mup-ps10 NCBI_Gene:108168721,ENSEMBL:ENSMUSG00000082173 MGI:3649623 pseudogene major urinary protein, pseudogene 10
4 gene 61.300023 61.304000 negative MGI_C57BL6J_3702005 Mup14 NCBI_Gene:100039116,ENSEMBL:ENSMUSG00000073830 MGI:3702005 protein coding gene major urinary protein 14
4 pseudogene 61.318730 61.326376 positive MGI_C57BL6J_3649621 Mup-ps11 NCBI_Gene:102640754,ENSEMBL:ENSMUSG00000095978 MGI:3649621 pseudogene major urinary protein, pseudogene 11
4 gene 61.435787 61.439743 negative MGI_C57BL6J_3780235 Mup15 NCBI_Gene:100039150,ENSEMBL:ENSMUSG00000096674 MGI:3780235 protein coding gene major urinary protein 15
4 pseudogene 61.440589 61.538481 positive MGI_C57BL6J_3783148 Mup-ps12 NCBI_Gene:100039019,ENSEMBL:ENSMUSG00000073835 MGI:3783148 pseudogene major urinary protein, pseudogene 12
4 gene 61.515592 61.519531 negative MGI_C57BL6J_3780250 Mup16 NCBI_Gene:100039177,ENSEMBL:ENSMUSG00000078675 MGI:3780250 protein coding gene major urinary protein 16
4 pseudogene 61.534230 61.536973 positive MGI_C57BL6J_3802118 Mup-ps13 ENSEMBL:ENSMUSG00000095532 MGI:3802118 pseudogene major urinary protein, pseudogene 13
4 gene 61.591929 61.595871 negative MGI_C57BL6J_3705217 Mup17 NCBI_Gene:100039206,ENSEMBL:ENSMUSG00000096688 MGI:3705217 protein coding gene major urinary protein 17
4 pseudogene 61.608277 61.612033 positive MGI_C57BL6J_3651980 Mup-ps14 NCBI_Gene:621127,ENSEMBL:ENSMUSG00000082065 MGI:3651980 pseudogene major urinary protein, pseudogene 14
4 gene 61.670177 61.674136 negative MGI_C57BL6J_3705220 Mup18 NCBI_Gene:100048884,ENSEMBL:ENSMUSG00000078674 MGI:3705220 protein coding gene major urinary protein 18
4 pseudogene 61.675160 61.702433 positive MGI_C57BL6J_3652152 Mup-ps15 NCBI_Gene:102631971,ENSEMBL:ENSMUSG00000083304 MGI:3652152 pseudogene major urinary protein, pseudogene 15
4 pseudogene 61.750075 61.750360 positive MGI_C57BL6J_3649353 Gm12573 ENSEMBL:ENSMUSG00000095307 MGI:3649353 pseudogene predicted gene 12573
4 gene 61.778324 61.782269 negative MGI_C57BL6J_3705235 Mup19 NCBI_Gene:100189605,ENSEMBL:ENSMUSG00000078673 MGI:3705235 protein coding gene major urinary protein 19
4 pseudogene 61.783060 61.801230 positive MGI_C57BL6J_3645603 Mup-ps16 NCBI_Gene:667278,ENSEMBL:ENSMUSG00000090090 MGI:3645603 pseudogene major urinary protein, pseudogene 16
4 gene 61.783123 61.801286 positive MGI_C57BL6J_3712466 Gm13775 ENSEMBL:ENSMUSG00000081207 MGI:3712466 lncRNA gene predicted gene 13775
4 gene 61.831319 61.858043 negative MGI_C57BL6J_104974 Mup5 NCBI_Gene:17844,ENSEMBL:ENSMUSG00000058523 MGI:104974 protein coding gene major urinary protein 5
4 pseudogene 61.855404 61.856554 negative MGI_C57BL6J_3650815 Mup-ps23 ENSEMBL:ENSMUSG00000081755 MGI:3650815 pseudogene major urinary protein, pseudogene 23
4 pseudogene 61.857321 61.857876 negative MGI_C57BL6J_3705843 Mup-ps17 ENSEMBL:ENSMUSG00000081053 MGI:3705843 pseudogene major urinary protein, pseudogene 17
4 pseudogene 61.874700 61.883317 negative MGI_C57BL6J_3651979 Mup-ps18 NCBI_Gene:667295,ENSEMBL:ENSMUSG00000082363 MGI:3651979 pseudogene major urinary protein, pseudogene 18
4 pseudogene 61.948990 61.959979 negative MGI_C57BL6J_3652149 Mup-ps19 NCBI_Gene:100039305,ENSEMBL:ENSMUSG00000082644 MGI:3652149 pseudogene major urinary protein, pseudogene 19
4 gene 62.011410 62.054158 negative MGI_C57BL6J_3651981 Mup20 NCBI_Gene:381530,ENSEMBL:ENSMUSG00000078672 MGI:3651981 protein coding gene major urinary protein 20
4 pseudogene 62.012412 62.014857 negative MGI_C57BL6J_3651976 Mup-ps20 ENSEMBL:ENSMUSG00000084309 MGI:3651976 pseudogene major urinary protein, pseudogene 20
4 pseudogene 62.028396 62.031672 negative MGI_C57BL6J_3652151 Mup-ps21 NCBI_Gene:546832,ENSEMBL:ENSMUSG00000083524 MGI:3652151 pseudogene major urinary protein, pseudogene 21
4 gene 62.083476 62.087370 negative MGI_C57BL6J_97235 Mup3 NCBI_Gene:17842,ENSEMBL:ENSMUSG00000066154 MGI:97235 protein coding gene major urinary protein 3
4 gene 62.088283 62.098441 positive MGI_C57BL6J_3651135 Gm12909 NCBI_Gene:105243851,ENSEMBL:ENSMUSG00000085404 MGI:3651135 lncRNA gene predicted gene 12909
4 gene 62.112931 62.120929 positive MGI_C57BL6J_3651134 Gm12910 ENSEMBL:ENSMUSG00000086530 MGI:3651134 lncRNA gene predicted gene 12910
4 gene 62.147832 62.150863 negative MGI_C57BL6J_3650630 Mup21 NCBI_Gene:381531,ENSEMBL:ENSMUSG00000066153 MGI:3650630 protein coding gene major urinary protein 21
4 gene 62.189537 62.231047 negative MGI_C57BL6J_99181 Zfp37 NCBI_Gene:22696,ENSEMBL:ENSMUSG00000028389 MGI:99181 protein coding gene zinc finger protein 37
4 gene 62.208924 62.209402 positive MGI_C57BL6J_5589610 Gm30451 NCBI_Gene:102632358 MGI:5589610 lncRNA gene predicted gene, 30451
4 gene 62.225795 62.226546 negative MGI_C57BL6J_5589670 Gm30511 NA NA unclassified non-coding RNA gene predicted gene%2c 30511
4 gene 62.262562 62.298412 positive MGI_C57BL6J_1333844 Slc31a2 NCBI_Gene:20530,ENSEMBL:ENSMUSG00000066152 MGI:1333844 protein coding gene solute carrier family 31, member 2
4 gene 62.264314 62.264420 positive MGI_C57BL6J_5452925 Gm23148 ENSEMBL:ENSMUSG00000096713 MGI:5452925 snRNA gene predicted gene, 23148
4 gene 62.300342 62.360590 negative MGI_C57BL6J_2444782 Fkbp15 NCBI_Gene:338355,ENSEMBL:ENSMUSG00000066151 MGI:2444782 protein coding gene FK506 binding protein 15
4 gene 62.360582 62.391769 positive MGI_C57BL6J_1333843 Slc31a1 NCBI_Gene:20529,ENSEMBL:ENSMUSG00000066150 MGI:1333843 protein coding gene solute carrier family 31, member 1
4 gene 62.383654 62.408642 negative MGI_C57BL6J_1913690 Cdc26 NCBI_Gene:66440,ENSEMBL:ENSMUSG00000066149 MGI:1913690 protein coding gene cell division cycle 26
4 gene 62.408767 62.426990 positive MGI_C57BL6J_1917302 Prpf4 NCBI_Gene:70052,ENSEMBL:ENSMUSG00000066148 MGI:1917302 protein coding gene pre-mRNA processing factor 4
4 gene 62.427536 62.435252 negative MGI_C57BL6J_1923322 Rnf183 NCBI_Gene:76072,ENSEMBL:ENSMUSG00000063851 MGI:1923322 protein coding gene ring finger protein 183
4 gene 62.434605 62.443851 positive MGI_C57BL6J_5589748 Gm30589 NCBI_Gene:102632542 MGI:5589748 lncRNA gene predicted gene, 30589
4 gene 62.448653 62.470965 negative MGI_C57BL6J_1918604 Wdr31 NCBI_Gene:71354,ENSEMBL:ENSMUSG00000028391 MGI:1918604 protein coding gene WD repeat domain 31
4 gene 62.480004 62.497300 positive MGI_C57BL6J_2177191 Bspry NCBI_Gene:192120,ENSEMBL:ENSMUSG00000028392 MGI:2177191 protein coding gene B-box and SPRY domain containing
4 gene 62.499008 62.503467 negative MGI_C57BL6J_1919998 Hdhd3 NCBI_Gene:72748,ENSEMBL:ENSMUSG00000038422 MGI:1919998 protein coding gene haloacid dehalogenase-like hydrolase domain containing 3
4 gene 62.505984 62.520063 negative MGI_C57BL6J_96853 Alad NCBI_Gene:17025,ENSEMBL:ENSMUSG00000028393 MGI:96853 protein coding gene aminolevulinate, delta-, dehydratase
4 gene 62.522649 62.525068 negative MGI_C57BL6J_1933378 Pole3 NCBI_Gene:59001,ENSEMBL:ENSMUSG00000028394 MGI:1933378 protein coding gene polymerase (DNA directed), epsilon 3 (p17 subunit)
4 gene 62.525107 62.553033 positive MGI_C57BL6J_3045314 4933430I17Rik NCBI_Gene:214106,ENSEMBL:ENSMUSG00000058046 MGI:3045314 protein coding gene RIKEN cDNA 4933430I17 gene
4 gene 62.559835 62.704001 positive MGI_C57BL6J_1354734 Rgs3 NCBI_Gene:50780,ENSEMBL:ENSMUSG00000059810 MGI:1354734 protein coding gene regulator of G-protein signaling 3
4 gene 62.627677 62.633712 negative MGI_C57BL6J_3650632 Gm11209 ENSEMBL:ENSMUSG00000085177 MGI:3650632 lncRNA gene predicted gene 11209
4 gene 62.705981 62.747147 positive MGI_C57BL6J_3650633 Gm11210 NCBI_Gene:105247140,ENSEMBL:ENSMUSG00000085223 MGI:3650633 lncRNA gene predicted gene 11210
4 gene 62.723515 62.727903 negative MGI_C57BL6J_3651244 Gm11211 NCBI_Gene:102632611,ENSEMBL:ENSMUSG00000086139 MGI:3651244 lncRNA gene predicted gene 11211
4 gene 62.765215 62.775577 negative MGI_C57BL6J_5589858 Gm30699 NCBI_Gene:102632694 MGI:5589858 lncRNA gene predicted gene, 30699
4 gene 62.812428 62.812560 positive MGI_C57BL6J_5453894 Gm24117 ENSEMBL:ENSMUSG00000077161 MGI:5453894 snoRNA gene predicted gene, 24117
4 gene 62.939341 62.939474 positive MGI_C57BL6J_5455168 Gm25391 ENSEMBL:ENSMUSG00000087967 MGI:5455168 snoRNA gene predicted gene, 25391
4 pseudogene 62.939521 62.939775 positive MGI_C57BL6J_3652240 Gm11481 ENSEMBL:ENSMUSG00000082048 MGI:3652240 pseudogene predicted gene 11481
4 pseudogene 62.939912 62.940570 positive MGI_C57BL6J_3652010 Gm11480 ENSEMBL:ENSMUSG00000083635 MGI:3652010 pseudogene predicted gene 11480
4 gene 62.965555 63.139709 positive MGI_C57BL6J_1919950 Zfp618 NCBI_Gene:72701,ENSEMBL:ENSMUSG00000028358 MGI:1919950 protein coding gene zinc finger protein 618
4 gene 62.978667 62.979625 negative MGI_C57BL6J_5589923 Gm30764 NCBI_Gene:102632780 MGI:5589923 lncRNA gene predicted gene, 30764
4 gene 63.143275 63.154799 negative MGI_C57BL6J_88002 Ambp NCBI_Gene:11699,ENSEMBL:ENSMUSG00000028356 MGI:88002 protein coding gene alpha 1 microglobulin/bikunin precursor
4 gene 63.157948 63.172146 negative MGI_C57BL6J_1098232 Kif12 NCBI_Gene:16552,ENSEMBL:ENSMUSG00000028357 MGI:1098232 protein coding gene kinesin family member 12
4 gene 63.214004 63.334991 positive MGI_C57BL6J_2672118 Col27a1 NCBI_Gene:373864,ENSEMBL:ENSMUSG00000045672 MGI:2672118 protein coding gene collagen, type XXVII, alpha 1
4 gene 63.256851 63.256932 positive MGI_C57BL6J_3629649 Mir455 miRBase:MI0004679,NCBI_Gene:735262,ENSEMBL:ENSMUSG00000070102 MGI:3629649 miRNA gene microRNA 455
4 gene 63.344556 63.348163 positive MGI_C57BL6J_97443 Orm1 NCBI_Gene:18405,ENSEMBL:ENSMUSG00000039196 MGI:97443 protein coding gene orosomucoid 1
4 pseudogene 63.350373 63.353957 positive MGI_C57BL6J_3651243 Gm11212 NCBI_Gene:435786,ENSEMBL:ENSMUSG00000082141 MGI:3651243 pseudogene predicted gene 11212
4 gene 63.355280 63.359511 positive MGI_C57BL6J_97445 Orm3 NCBI_Gene:18407,ENSEMBL:ENSMUSG00000028359 MGI:97445 protein coding gene orosomucoid 3
4 gene 63.362449 63.365878 positive MGI_C57BL6J_97444 Orm2 NCBI_Gene:18406,ENSEMBL:ENSMUSG00000061540 MGI:97444 protein coding gene orosomucoid 2
4 gene 63.367123 63.410758 negative MGI_C57BL6J_2140340 Akna NCBI_Gene:100182,ENSEMBL:ENSMUSG00000039158 MGI:2140340 protein coding gene AT-hook transcription factor
4 gene 63.377057 63.394018 positive MGI_C57BL6J_1914033 Aknaos NCBI_Gene:66783,ENSEMBL:ENSMUSG00000086953 MGI:1914033 antisense lncRNA gene AT-hook transcription factor, opposite strand
4 gene 63.414909 63.496076 negative MGI_C57BL6J_2682003 Whrn NCBI_Gene:73750,ENSEMBL:ENSMUSG00000039137 MGI:2682003 protein coding gene whirlin
4 gene 63.544765 63.550750 positive MGI_C57BL6J_1913540 Atp6v1g1 NCBI_Gene:66290,ENSEMBL:ENSMUSG00000039105 MGI:1913540 protein coding gene ATPase, H+ transporting, lysosomal V1 subunit G1
4 gene 63.545293 63.547859 positive MGI_C57BL6J_5621477 Gm38592 NCBI_Gene:102642011 MGI:5621477 lncRNA gene predicted gene, 38592
4 gene 63.558417 63.586357 positive MGI_C57BL6J_1913920 Tmem268 NCBI_Gene:230279,ENSEMBL:ENSMUSG00000045917 MGI:1913920 protein coding gene transmembrane protein 268
4 pseudogene 63.567414 63.567660 negative MGI_C57BL6J_3652237 Gm11483 ENSEMBL:ENSMUSG00000083943 MGI:3652237 pseudogene predicted gene 11483
4 gene 63.567662 63.567768 negative MGI_C57BL6J_5454225 Gm24448 ENSEMBL:ENSMUSG00000065913 MGI:5454225 snRNA gene predicted gene, 24448
4 gene 63.596901 63.605261 negative MGI_C57BL6J_3701774 Gm11213 NCBI_Gene:670833,ENSEMBL:ENSMUSG00000084782 MGI:3701774 lncRNA gene predicted gene 11213
4 gene 63.607085 63.622450 negative MGI_C57BL6J_1922774 Tex48 NCBI_Gene:75524,ENSEMBL:ENSMUSG00000058935 MGI:1922774 protein coding gene testis expressed 48
4 gene 63.631682 63.631788 negative MGI_C57BL6J_5454011 Gm24234 ENSEMBL:ENSMUSG00000077504 MGI:5454011 snRNA gene predicted gene, 24234
4 gene 63.634415 63.641981 positive MGI_C57BL6J_3652238 Gm11482 NCBI_Gene:102632940,ENSEMBL:ENSMUSG00000086817 MGI:3652238 lncRNA gene predicted gene 11482
4 gene 63.662157 63.663393 negative MGI_C57BL6J_3651045 Gm11214 NCBI_Gene:667451,ENSEMBL:ENSMUSG00000099294 MGI:3651045 protein coding gene predicted gene 11214
4 gene 63.696384 63.744868 positive MGI_C57BL6J_5625180 Gm42295 NCBI_Gene:105247142 MGI:5625180 lncRNA gene predicted gene, 42295
4 gene 63.724603 63.745113 negative MGI_C57BL6J_2180140 Tnfsf15 NCBI_Gene:326623,ENSEMBL:ENSMUSG00000050395 MGI:2180140 protein coding gene tumor necrosis factor (ligand) superfamily, member 15
4 gene 63.745032 63.773177 positive MGI_C57BL6J_5625179 Gm42294 NCBI_Gene:105247141 MGI:5625179 lncRNA gene predicted gene, 42294
4 gene 63.831308 63.861508 negative MGI_C57BL6J_88328 Tnfsf8 NCBI_Gene:21949,ENSEMBL:ENSMUSG00000028362 MGI:88328 protein coding gene tumor necrosis factor (ligand) superfamily, member 8
4 pseudogene 63.895512 63.896124 negative MGI_C57BL6J_3651043 Rpl17-ps4 NCBI_Gene:435787,ENSEMBL:ENSMUSG00000084345 MGI:3651043 pseudogene ribosomal protein L17, pseudogene 4
4 gene 63.959785 64.047015 negative MGI_C57BL6J_101922 Tnc NCBI_Gene:21923,ENSEMBL:ENSMUSG00000028364 MGI:101922 protein coding gene tenascin C
4 gene 63.979854 64.149924 positive MGI_C57BL6J_1915353 8030451A03Rik NCBI_Gene:100504061,ENSEMBL:ENSMUSG00000073821 MGI:1915353 lncRNA gene RIKEN cDNA 8030451A03 gene
4 gene 64.075533 64.083814 positive MGI_C57BL6J_3651044 Gm11216 ENSEMBL:ENSMUSG00000086755 MGI:3651044 lncRNA gene predicted gene 11216
4 gene 64.154280 64.286118 positive MGI_C57BL6J_5590274 Gm31115 NCBI_Gene:102633240 MGI:5590274 lncRNA gene predicted gene, 31115
4 gene 64.254053 64.276603 negative MGI_C57BL6J_3651042 Gm11217 NCBI_Gene:102633436,ENSEMBL:ENSMUSG00000085032 MGI:3651042 lncRNA gene predicted gene 11217
4 gene 64.444730 64.444858 positive MGI_C57BL6J_5453727 Gm23950 ENSEMBL:ENSMUSG00000077214 MGI:5453727 snoRNA gene predicted gene, 23950
4 pseudogene 64.856293 64.858139 negative MGI_C57BL6J_3651636 Gm11218 NCBI_Gene:100502689,ENSEMBL:ENSMUSG00000081941 MGI:3651636 pseudogene predicted gene 11218
4 pseudogene 65.011230 65.011587 positive MGI_C57BL6J_3651487 Gm11219 ENSEMBL:ENSMUSG00000080805 MGI:3651487 pseudogene predicted gene 11219
4 gene 65.124174 65.357512 positive MGI_C57BL6J_97479 Pappa NCBI_Gene:18491,ENSEMBL:ENSMUSG00000028370 MGI:97479 protein coding gene pregnancy-associated plasma protein A
4 gene 65.380803 66.404611 negative MGI_C57BL6J_1889277 Astn2 NCBI_Gene:56079,ENSEMBL:ENSMUSG00000028373 MGI:1889277 protein coding gene astrotactin 2
4 gene 65.604986 65.616240 positive MGI_C57BL6J_1917057 Trim32 NCBI_Gene:69807,ENSEMBL:ENSMUSG00000051675 MGI:1917057 protein coding gene tripartite motif-containing 32
4 gene 65.623203 65.626064 positive MGI_C57BL6J_2441665 3632413A11Rik NA NA unclassified gene RIKEN cDNA 3632413A11 gene
4 gene 65.628952 65.634800 positive MGI_C57BL6J_5590692 Gm31533 NCBI_Gene:102633792 MGI:5590692 lncRNA gene predicted gene, 31533
4 pseudogene 66.353849 66.354186 positive MGI_C57BL6J_3651701 Gm11484 ENSEMBL:ENSMUSG00000083080 MGI:3651701 pseudogene predicted gene 11484
4 gene 66.544061 66.544193 positive MGI_C57BL6J_5455257 Gm25480 ENSEMBL:ENSMUSG00000065151 MGI:5455257 snoRNA gene predicted gene, 25480
4 pseudogene 66.725070 66.725544 negative MGI_C57BL6J_3651695 Gm11220 NCBI_Gene:667499,ENSEMBL:ENSMUSG00000082053 MGI:3651695 pseudogene predicted gene 11220
4 gene 66.827551 66.930284 positive MGI_C57BL6J_96824 Tlr4 NCBI_Gene:21898,ENSEMBL:ENSMUSG00000039005 MGI:96824 protein coding gene toll-like receptor 4
4 pseudogene 67.165479 67.165847 positive MGI_C57BL6J_3651007 Gm11403 ENSEMBL:ENSMUSG00000081435 MGI:3651007 pseudogene predicted gene 11403
4 pseudogene 67.518306 67.518994 negative MGI_C57BL6J_104763 Hmgb1-rs18 NCBI_Gene:15298,ENSEMBL:ENSMUSG00000080815 MGI:104763 pseudogene high mobility group box 1, related sequence 18
4 gene 67.633153 67.633229 positive MGI_C57BL6J_5690889 Gm44497 ENSEMBL:ENSMUSG00000106523 MGI:5690889 miRNA gene predicted gene, 44497
4 pseudogene 67.930855 67.931776 positive MGI_C57BL6J_3650834 Gm11249 NCBI_Gene:433715,ENSEMBL:ENSMUSG00000083087 MGI:3650834 pseudogene predicted gene 11249
4 gene 68.023031 68.137113 positive MGI_C57BL6J_3650096 Gm11751 ENSEMBL:ENSMUSG00000086364 MGI:3650096 lncRNA gene predicted gene 11751
4 gene 68.182532 68.182702 positive MGI_C57BL6J_5453515 Gm23738 ENSEMBL:ENSMUSG00000064762 MGI:5453515 snRNA gene predicted gene, 23738
4 pseudogene 68.301245 68.303379 negative MGI_C57BL6J_98536 Tcp1-ps1 NCBI_Gene:21455,ENSEMBL:ENSMUSG00000081231 MGI:98536 pseudogene t-complex protein 1, pseudogene 1
4 gene 68.312467 68.321961 negative MGI_C57BL6J_3652009 Gm12911 NCBI_Gene:102633975,ENSEMBL:ENSMUSG00000086790 MGI:3652009 lncRNA gene predicted gene 12911
4 gene 68.761372 68.954397 negative MGI_C57BL6J_1928478 Brinp1 NCBI_Gene:56710,ENSEMBL:ENSMUSG00000028351 MGI:1928478 protein coding gene bone morphogenic protein/retinoic acid inducible neural specific 1
4 gene 68.800552 68.801630 negative MGI_C57BL6J_1924804 9330154F10Rik NA NA unclassified gene RIKEN cDNA 9330154F10 gene
4 gene 68.957912 68.959666 positive MGI_C57BL6J_5625181 Gm42296 NCBI_Gene:105247144 MGI:5625181 lncRNA gene predicted gene, 42296
4 gene 69.110671 69.110777 positive MGI_C57BL6J_5454474 Gm24697 ENSEMBL:ENSMUSG00000065815 MGI:5454474 snRNA gene predicted gene, 24697
4 gene 69.167538 69.199826 negative MGI_C57BL6J_5826521 Gm46884 NCBI_Gene:108168996 MGI:5826521 lncRNA gene predicted gene, 46884
4 gene 69.259299 69.262035 negative MGI_C57BL6J_5591064 Gm31905 NCBI_Gene:102634283 MGI:5591064 lncRNA gene predicted gene, 31905
4 pseudogene 69.291612 69.295121 negative MGI_C57BL6J_3651011 Gm11404 NCBI_Gene:100418187,ENSEMBL:ENSMUSG00000082553 MGI:3651011 pseudogene predicted gene 11404
4 pseudogene 69.691955 69.692651 positive MGI_C57BL6J_3651633 Gm11221 NCBI_Gene:622491,ENSEMBL:ENSMUSG00000082998 MGI:3651633 pseudogene predicted gene 11221
4 pseudogene 69.853947 69.854684 positive MGI_C57BL6J_3651632 Gm11222 NCBI_Gene:433716,ENSEMBL:ENSMUSG00000085627 MGI:3651632 pseudogene predicted gene 11222
4 pseudogene 69.925201 69.926170 negative MGI_C57BL6J_3651631 Gm11223 NCBI_Gene:100039888,ENSEMBL:ENSMUSG00000046341 MGI:3651631 pseudogene predicted gene 11223
4 pseudogene 69.954166 69.955276 negative MGI_C57BL6J_3651640 Gm11224 NCBI_Gene:242497,ENSEMBL:ENSMUSG00000084342 MGI:3651640 pseudogene predicted gene 11224
4 pseudogene 70.047157 70.048205 positive MGI_C57BL6J_3651505 Gm11225 NCBI_Gene:671064,ENSEMBL:ENSMUSG00000082368 MGI:3651505 pseudogene predicted gene 11225
4 gene 70.216855 70.410443 negative MGI_C57BL6J_2384875 Cdk5rap2 NCBI_Gene:214444,ENSEMBL:ENSMUSG00000039298 MGI:2384875 protein coding gene CDK5 regulatory subunit associated protein 2
4 pseudogene 70.247954 70.249435 negative MGI_C57BL6J_3650241 Ywhaq-ps3 NCBI_Gene:102634437,ENSEMBL:ENSMUSG00000080902 MGI:3650241 pseudogene tyrosine 3-monooxygenase/tryptophan 5-monooxygenase activation protein theta, pseudogene 3
4 gene 70.412618 70.412923 negative MGI_C57BL6J_5456097 Gm26320 ENSEMBL:ENSMUSG00000088367 MGI:5456097 unclassified non-coding RNA gene predicted gene, 26320
4 gene 70.427065 70.534995 negative MGI_C57BL6J_1918264 Megf9 NCBI_Gene:230316,ENSEMBL:ENSMUSG00000039270 MGI:1918264 protein coding gene multiple EGF-like-domains 9
4 gene 70.553680 70.665012 positive MGI_C57BL6J_5591368 Gm32209 NCBI_Gene:102634677 MGI:5591368 lncRNA gene predicted gene, 32209
4 gene 70.679233 70.691711 positive MGI_C57BL6J_5625182 Gm42297 NCBI_Gene:105247145 MGI:5625182 lncRNA gene predicted gene, 42297
4 pseudogene 71.072627 71.074766 positive MGI_C57BL6J_3651434 Gm11227 NCBI_Gene:100039565,ENSEMBL:ENSMUSG00000083549 MGI:3651434 pseudogene predicted gene 11227
4 gene 71.075109 71.131133 negative MGI_C57BL6J_3651435 Gm11228 NCBI_Gene:102634783,ENSEMBL:ENSMUSG00000084937 MGI:3651435 lncRNA gene predicted gene 11228
4 pseudogene 71.094603 71.095899 negative MGI_C57BL6J_5010719 Gm18534 NCBI_Gene:100417328 MGI:5010719 pseudogene predicted gene, 18534
4 pseudogene 71.285942 71.286378 positive MGI_C57BL6J_3651948 Gm11229 ENSEMBL:ENSMUSG00000082017 MGI:3651948 pseudogene predicted gene 11229
4 pseudogene 71.370695 71.371217 negative MGI_C57BL6J_3650249 Rps18-ps1 NCBI_Gene:100039979,ENSEMBL:ENSMUSG00000083914 MGI:3650249 pseudogene ribosomal protein S18, pseudogene 1
4 gene 71.381969 71.397235 positive MGI_C57BL6J_5625183 Gm42298 NCBI_Gene:105247146 MGI:5625183 lncRNA gene predicted gene, 42298
4 pseudogene 71.677470 71.679805 positive MGI_C57BL6J_3650253 Gm11231 NCBI_Gene:667638,ENSEMBL:ENSMUSG00000082432 MGI:3650253 pseudogene predicted gene 11231
4 gene 71.755643 71.757965 negative MGI_C57BL6J_3651439 Gm11232 NCBI_Gene:102634852,ENSEMBL:ENSMUSG00000066141 MGI:3651439 protein coding gene predicted gene 11232
4 pseudogene 71.867988 71.868977 positive MGI_C57BL6J_3650258 Gm11233 ENSEMBL:ENSMUSG00000081117 MGI:3650258 pseudogene predicted gene 11233
4 gene 71.980477 71.999559 positive MGI_C57BL6J_3651441 Gm11234 ENSEMBL:ENSMUSG00000086696 MGI:3651441 lncRNA gene predicted gene 11234
4 gene 72.109945 72.201055 negative MGI_C57BL6J_104636 Tle1 NCBI_Gene:21885,ENSEMBL:ENSMUSG00000008305 MGI:104636 protein coding gene transducin-like enhancer of split 1
4 gene 72.168768 72.169449 positive MGI_C57BL6J_3651181 Gm11250 ENSEMBL:ENSMUSG00000086027 MGI:3651181 lncRNA gene predicted gene 11250
4 gene 72.201244 72.215352 positive MGI_C57BL6J_1915535 C630043F03Rik NCBI_Gene:68285,ENSEMBL:ENSMUSG00000084910 MGI:1915535 lncRNA gene RIKEN cDNA C630043F03 gene
4 pseudogene 72.542666 72.542998 positive MGI_C57BL6J_3651442 Gm11235 ENSEMBL:ENSMUSG00000083372 MGI:3651442 pseudogene predicted gene 11235
4 gene 72.850583 72.852634 negative MGI_C57BL6J_2447811 Aldoart1 NCBI_Gene:353204,ENSEMBL:ENSMUSG00000059343 MGI:2447811 protein coding gene aldolase 1 A, retrogene 1
4 pseudogene 72.893781 72.894378 positive MGI_C57BL6J_3648217 Gm5287 NCBI_Gene:384113,ENSEMBL:ENSMUSG00000084173 MGI:3648217 pseudogene predicted gene 5287
4 gene 72.906201 72.906338 negative MGI_C57BL6J_5455430 Gm25653 ENSEMBL:ENSMUSG00000089098 MGI:5455430 snoRNA gene predicted gene, 25653
4 pseudogene 73.029819 73.036074 positive MGI_C57BL6J_3651054 Gm11251 NCBI_Gene:667713,ENSEMBL:ENSMUSG00000084162 MGI:3651054 pseudogene predicted gene 11251
4 gene 73.114657 73.114783 positive MGI_C57BL6J_5455546 Gm25769 ENSEMBL:ENSMUSG00000089194 MGI:5455546 snoRNA gene predicted gene, 25769
4 gene 73.391651 73.391929 positive MGI_C57BL6J_1100493 Gtayu1 NA NA unclassified gene gene trap AYU 1
4 gene 73.401032 73.407404 negative MGI_C57BL6J_3650704 Gm11487 NCBI_Gene:433719,ENSEMBL:ENSMUSG00000066137 MGI:3650704 protein coding gene predicted gene 11487
4 pseudogene 73.415301 73.418690 negative MGI_C57BL6J_3650706 Gm11486 ENSEMBL:ENSMUSG00000080222 MGI:3650706 pseudogene predicted gene 11486
4 pseudogene 73.422145 73.423319 negative MGI_C57BL6J_3705569 Gm11485 NCBI_Gene:667722,ENSEMBL:ENSMUSG00000082566 MGI:3705569 pseudogene predicted gene 11485
4 pseudogene 73.497615 73.498517 negative MGI_C57BL6J_3650705 Gm11488 NCBI_Gene:623115,ENSEMBL:ENSMUSG00000081871 MGI:3650705 pseudogene predicted gene 11488
4 gene 73.589082 73.589214 negative MGI_C57BL6J_5453947 Gm24170 ENSEMBL:ENSMUSG00000077312 MGI:5453947 snoRNA gene predicted gene, 24170
4 gene 73.605544 73.611922 positive MGI_C57BL6J_5621308 Gm38423 NCBI_Gene:100502924 MGI:5621308 protein coding gene predicted gene, 38423
4 gene 73.607881 73.657292 positive MGI_C57BL6J_3702316 Gm11238 NCBI_Gene:100502896,ENSEMBL:ENSMUSG00000095935 MGI:3702316 protein coding gene predicted gene 11238
4 gene 73.620648 73.627029 positive MGI_C57BL6J_3702292 Gm11237 NCBI_Gene:623197,ENSEMBL:ENSMUSG00000094116 MGI:3702292 protein coding gene predicted gene 11237
4 gene 73.635785 73.642163 positive MGI_C57BL6J_3702277 Gm11236 NCBI_Gene:100862015,ENSEMBL:ENSMUSG00000096700 MGI:3702277 protein coding gene predicted gene 11236
4 gene 73.666018 73.672398 positive MGI_C57BL6J_3702319 Gm11239 NCBI_Gene:101055863,ENSEMBL:ENSMUSG00000095048 MGI:3702319 protein coding gene predicted gene 11239
4 gene 73.681151 73.687559 positive MGI_C57BL6J_2685274 Gm428 NCBI_Gene:242502,ENSEMBL:ENSMUSG00000095341 MGI:2685274 protein coding gene predicted gene 428
4 gene 73.714577 73.791315 negative MGI_C57BL6J_2448565 Rasef NCBI_Gene:242505,ENSEMBL:ENSMUSG00000043003 MGI:2448565 protein coding gene RAS and EF hand domain containing
4 gene 73.791244 73.798378 positive MGI_C57BL6J_3651058 Gm11240 NCBI_Gene:667768,ENSEMBL:ENSMUSG00000085034 MGI:3651058 lncRNA gene predicted gene 11240
4 pseudogene 73.864397 73.865092 positive MGI_C57BL6J_3650139 Gm13867 ENSEMBL:ENSMUSG00000083530 MGI:3650139 pseudogene predicted gene 13867
4 gene 73.872219 73.876266 negative MGI_C57BL6J_3702099 Gm11758 NCBI_Gene:545637,ENSEMBL:ENSMUSG00000096530 MGI:3702099 protein coding gene predicted gene 11758
4 gene 73.887066 73.891112 negative MGI_C57BL6J_3702097 Gm11757 NCBI_Gene:623272,ENSEMBL:ENSMUSG00000096750 MGI:3702097 protein coding gene predicted gene 11757
4 gene 73.901906 73.905953 negative MGI_C57BL6J_3702126 Gm13871 NCBI_Gene:667780,ENSEMBL:ENSMUSG00000096333 MGI:3702126 protein coding gene predicted gene 13871
4 gene 73.916727 73.920760 negative MGI_C57BL6J_3702095 Gm11756 NCBI_Gene:623281,ENSEMBL:ENSMUSG00000093962 MGI:3702095 protein coding gene predicted gene 11756
4 gene 73.939371 73.950856 negative MGI_C57BL6J_1916780 2310002L09Rik NCBI_Gene:71886,ENSEMBL:ENSMUSG00000028396 MGI:1916780 protein coding gene RIKEN cDNA 2310002L09 gene
4 gene 74.013442 74.202214 positive MGI_C57BL6J_2442466 Frmd3 NCBI_Gene:242506,ENSEMBL:ENSMUSG00000049122 MGI:2442466 protein coding gene FERM domain containing 3
4 pseudogene 74.044367 74.045221 positive MGI_C57BL6J_3651479 Gm11760 NCBI_Gene:100384873,ENSEMBL:ENSMUSG00000081048 MGI:3651479 pseudogene predicted gene 11760
4 pseudogene 74.228197 74.229752 positive MGI_C57BL6J_3651226 Gm11405 NCBI_Gene:100039774,ENSEMBL:ENSMUSG00000083767 MGI:3651226 pseudogene predicted gene 11405
4 gene 74.242497 74.405864 positive MGI_C57BL6J_1924054 Kdm4c NCBI_Gene:76804,ENSEMBL:ENSMUSG00000028397 MGI:1924054 protein coding gene lysine (K)-specific demethylase 4C
4 gene 74.250324 74.251714 negative MGI_C57BL6J_3698879 A230083N12Rik ENSEMBL:ENSMUSG00000085482 MGI:3698879 lncRNA gene RIKEN cDNA A230083N12 gene
4 gene 74.364702 74.365014 positive MGI_C57BL6J_1919791 2700003L17Rik NA NA unclassified gene RIKEN cDNA 2700003L17 gene
4 gene 74.635214 74.635351 positive MGI_C57BL6J_5456156 Gm26379 ENSEMBL:ENSMUSG00000099334,ENSEMBL:ENSMUSG00000104700 MGI:5456156 snoRNA gene predicted gene, 26379
4 pseudogene 74.663667 74.664532 positive MGI_C57BL6J_3649979 Gm11254 NCBI_Gene:100417943,ENSEMBL:ENSMUSG00000081438 MGI:3649979 pseudogene predicted gene 11254
4 pseudogene 74.687655 74.689338 negative MGI_C57BL6J_3649983 Gm11258 NCBI_Gene:100039814,ENSEMBL:ENSMUSG00000083659 MGI:3649983 pseudogene predicted gene 11258
4 pseudogene 74.903963 74.904918 negative MGI_C57BL6J_5010929 Gm18744 NCBI_Gene:100417656 MGI:5010929 pseudogene predicted gene, 18744
4 pseudogene 75.068013 75.071966 positive MGI_C57BL6J_5826499 Gm46862 NCBI_Gene:108168965 MGI:5826499 pseudogene predicted gene, 46862
4 pseudogene 75.081500 75.081700 negative MGI_C57BL6J_3649981 Gm11253 ENSEMBL:ENSMUSG00000082533 MGI:3649981 pseudogene predicted gene 11253
4 pseudogene 75.128710 75.129642 positive MGI_C57BL6J_3649985 Gm11257 NCBI_Gene:100384870,ENSEMBL:ENSMUSG00000084311 MGI:3649985 pseudogene predicted gene 11257
4 pseudogene 75.147542 75.149308 positive MGI_C57BL6J_3649320 Gm12912 NCBI_Gene:636847,ENSEMBL:ENSMUSG00000081067 MGI:3649320 pseudogene predicted gene 12912
4 gene 75.277354 75.278305 negative MGI_C57BL6J_1914178 Dmac1 NCBI_Gene:66928,ENSEMBL:ENSMUSG00000028398 MGI:1914178 protein coding gene distal membrane arm assembly complex 1
4 gene 75.280626 75.280755 negative MGI_C57BL6J_5452641 Gm22864 ENSEMBL:ENSMUSG00000065884 MGI:5452641 snoRNA gene predicted gene, 22864
4 pseudogene 75.324501 75.325680 positive MGI_C57BL6J_3649873 Gm11255 NCBI_Gene:623529,ENSEMBL:ENSMUSG00000083224 MGI:3649873 pseudogene predicted gene 11255
4 pseudogene 75.330902 75.332351 positive MGI_C57BL6J_5010839 Gm18654 NCBI_Gene:100417504 MGI:5010839 pseudogene predicted gene, 18654
4 pseudogene 75.380760 75.381888 positive MGI_C57BL6J_3649975 Gm11259 NCBI_Gene:100039833,ENSEMBL:ENSMUSG00000084026 MGI:3649975 pseudogene predicted gene 11259
4 gene 75.559631 75.588755 negative MGI_C57BL6J_5625185 Gm42300 NCBI_Gene:105247148 MGI:5625185 lncRNA gene predicted gene, 42300
4 gene 75.567293 75.583723 negative MGI_C57BL6J_5625184 Gm42299 NCBI_Gene:105247147 MGI:5625184 lncRNA gene predicted gene, 42299
4 pseudogene 75.854518 75.855394 positive MGI_C57BL6J_3650655 Gm11256 NCBI_Gene:100039884,ENSEMBL:ENSMUSG00000084253 MGI:3650655 pseudogene predicted gene 11256
4 pseudogene 75.902260 75.903155 negative MGI_C57BL6J_3652121 Gm11241 NCBI_Gene:667845,ENSEMBL:ENSMUSG00000081844 MGI:3652121 pseudogene predicted gene 11241
4 gene 75.941237 78.211961 negative MGI_C57BL6J_97812 Ptprd NCBI_Gene:19266,ENSEMBL:ENSMUSG00000028399 MGI:97812 protein coding gene protein tyrosine phosphatase, receptor type, D
4 gene 76.192513 76.196634 negative MGI_C57BL6J_2442984 A230006I23Rik NA NA unclassified gene RIKEN cDNA A230006I23 gene
4 gene 76.338163 76.345386 positive MGI_C57BL6J_5826530 Gm46893 NCBI_Gene:108169012 MGI:5826530 lncRNA gene predicted gene, 46893
4 pseudogene 76.393154 76.394092 positive MGI_C57BL6J_3651309 Gm11252 ENSEMBL:ENSMUSG00000080780 MGI:3651309 pseudogene predicted gene 11252
4 gene 76.450773 76.490114 positive MGI_C57BL6J_5625188 Gm42303 NCBI_Gene:105247151,ENSEMBL:ENSMUSG00000110373 MGI:5625188 lncRNA gene predicted gene, 42303
4 pseudogene 76.692143 76.694632 positive MGI_C57BL6J_3652117 Gm11242 NCBI_Gene:100422786,ENSEMBL:ENSMUSG00000083050 MGI:3652117 pseudogene predicted gene 11242
4 gene 76.791191 76.813718 positive MGI_C57BL6J_5625187 Gm42302 NCBI_Gene:105247150 MGI:5625187 lncRNA gene predicted gene, 42302
4 pseudogene 76.793729 76.794203 positive MGI_C57BL6J_3652116 Gm11243 NCBI_Gene:667858,ENSEMBL:ENSMUSG00000081890 MGI:3652116 pseudogene predicted gene 11243
4 pseudogene 76.811555 76.811791 negative MGI_C57BL6J_3651883 Gm11244 ENSEMBL:ENSMUSG00000081936 MGI:3651883 pseudogene predicted gene 11244
4 pseudogene 76.837769 76.838815 positive MGI_C57BL6J_3651884 Gm11245 NCBI_Gene:667862,ENSEMBL:ENSMUSG00000084090 MGI:3651884 pseudogene predicted gene 11245
4 pseudogene 76.927311 76.927655 positive MGI_C57BL6J_3651881 Gm11246 ENSEMBL:ENSMUSG00000081656 MGI:3651881 pseudogene predicted gene 11246
4 gene 76.958422 76.958498 negative MGI_C57BL6J_5452936 Gm23159 ENSEMBL:ENSMUSG00000092829 MGI:5452936 miRNA gene predicted gene, 23159
4 gene 77.310822 77.314607 positive MGI_C57BL6J_5621531 Gm38646 NCBI_Gene:102642962 MGI:5621531 lncRNA gene predicted gene, 38646
4 pseudogene 78.011434 78.012670 negative MGI_C57BL6J_5585257 Fkbp1a-ps4 NCBI_Gene:103926449 MGI:5585257 pseudogene FK506 binding protein 1a, pseudogene 4
4 gene 78.159886 78.161535 negative MGI_C57BL6J_1923471 6430598H11Rik NA NA unclassified gene RIKEN cDNA 6430598H11 gene
4 gene 78.205852 78.221035 positive MGI_C57BL6J_2442149 B230208B08Rik NCBI_Gene:102634132,ENSEMBL:ENSMUSG00000092492 MGI:2442149 lncRNA gene RIKEN cDNA B230208B08 gene
4 pseudogene 78.233986 78.234927 positive MGI_C57BL6J_3651928 Gm11260 NCBI_Gene:100039996,ENSEMBL:ENSMUSG00000082351 MGI:3651928 pseudogene predicted gene 11260
4 gene 78.267867 78.382708 positive MGI_C57BL6J_5591704 Gm32545 NCBI_Gene:102635126 MGI:5591704 lncRNA gene predicted gene, 32545
4 gene 78.594047 78.597484 positive MGI_C57BL6J_3647836 A430085M09Rik NCBI_Gene:623726 MGI:3647836 lncRNA gene RIKEN cDNA A430085M09 gene
4 gene 78.659858 78.661588 negative MGI_C57BL6J_3650239 Gm11261 ENSEMBL:ENSMUSG00000085840 MGI:3650239 lncRNA gene predicted gene 11261
4 gene 78.670147 78.670232 positive MGI_C57BL6J_5452039 Gm22262 ENSEMBL:ENSMUSG00000089338 MGI:5452039 unclassified non-coding RNA gene predicted gene, 22262
4 pseudogene 78.697652 78.698928 positive MGI_C57BL6J_3650238 Gm11262 ENSEMBL:ENSMUSG00000083629 MGI:3650238 pseudogene predicted gene 11262
4 gene 79.244587 79.244709 negative MGI_C57BL6J_5455613 Gm25836 ENSEMBL:ENSMUSG00000089543 MGI:5455613 snoRNA gene predicted gene, 25836
4 pseudogene 79.327708 79.328456 positive MGI_C57BL6J_3651899 Gm11263 NCBI_Gene:667922,ENSEMBL:ENSMUSG00000083496 MGI:3651899 pseudogene predicted gene 11263
4 pseudogene 79.874351 79.874753 positive MGI_C57BL6J_3652024 Gm11409 ENSEMBL:ENSMUSG00000084248 MGI:3652024 pseudogene predicted gene 11409
4 pseudogene 80.002331 80.003388 positive MGI_C57BL6J_3651131 Gm11407 ENSEMBL:ENSMUSG00000082179 MGI:3651131 pseudogene predicted gene 11407
4 pseudogene 80.003396 80.003914 negative MGI_C57BL6J_3651130 Gm11408 ENSEMBL:ENSMUSG00000083076 MGI:3651130 pseudogene predicted gene 11408
4 pseudogene 80.003989 80.005131 positive MGI_C57BL6J_3652015 Gm11410 ENSEMBL:ENSMUSG00000083219 MGI:3652015 pseudogene predicted gene 11410
4 pseudogene 80.440398 80.440881 positive MGI_C57BL6J_3651132 Gm11406 ENSEMBL:ENSMUSG00000082555 MGI:3651132 pseudogene predicted gene 11406
4 gene 80.509338 80.630259 negative MGI_C57BL6J_5591817 Gm32658 NCBI_Gene:102635277 MGI:5591817 lncRNA gene predicted gene, 32658
4 gene 80.703650 80.726133 positive MGI_C57BL6J_5826522 Gm46885 NCBI_Gene:108168997 MGI:5826522 lncRNA gene predicted gene, 46885
4 gene 80.740299 80.744128 positive MGI_C57BL6J_5625189 Gm42304 NCBI_Gene:105247152 MGI:5625189 lncRNA gene predicted gene, 42304
4 gene 80.834123 80.851736 positive MGI_C57BL6J_98881 Tyrp1 NCBI_Gene:22178,ENSEMBL:ENSMUSG00000005994 MGI:98881 protein coding gene tyrosinase-related protein 1
4 gene 80.910646 80.955628 positive MGI_C57BL6J_106510 Lurap1l NCBI_Gene:52829,ENSEMBL:ENSMUSG00000048706 MGI:106510 protein coding gene leucine rich adaptor protein 1-like
4 gene 80.914349 80.914810 positive MGI_C57BL6J_1923975 2010003D24Rik NA NA unclassified gene RIKEN cDNA 2010003D24 gene
4 gene 80.917390 80.918762 positive MGI_C57BL6J_1924589 9430051O21Rik NA NA unclassified gene RIKEN cDNA 9430051O21 gene
4 gene 80.967444 80.967539 positive MGI_C57BL6J_5530834 Gm27452 ENSEMBL:ENSMUSG00000099273 MGI:5530834 miRNA gene predicted gene, 27452
4 gene 81.278499 81.442914 negative MGI_C57BL6J_1343489 Mpdz NCBI_Gene:17475,ENSEMBL:ENSMUSG00000028402 MGI:1343489 protein coding gene multiple PDZ domain protein
4 gene 81.338274 81.338404 negative MGI_C57BL6J_5455580 Gm25803 ENSEMBL:ENSMUSG00000077607 MGI:5455580 snoRNA gene predicted gene, 25803
4 pseudogene 81.455937 81.484777 negative MGI_C57BL6J_3651002 Gm11765 NCBI_Gene:100040131,ENSEMBL:ENSMUSG00000081391 MGI:3651002 pseudogene predicted gene 11765
4 pseudogene 81.696441 81.697159 positive MGI_C57BL6J_3650904 Gm11411 ENSEMBL:ENSMUSG00000083385 MGI:3650904 pseudogene predicted gene 11411
4 gene 81.743146 81.789097 positive MGI_C57BL6J_3650905 Gm11412 NCBI_Gene:102635467,ENSEMBL:ENSMUSG00000087540 MGI:3650905 lncRNA gene predicted gene 11412
4 gene 81.918513 81.918623 positive MGI_C57BL6J_4422052 n-R5s187 ENSEMBL:ENSMUSG00000084718 MGI:4422052 rRNA gene nuclear encoded rRNA 5S 187
4 gene 81.930478 81.932374 negative MGI_C57BL6J_3650483 Gm12914 ENSEMBL:ENSMUSG00000087608 MGI:3650483 lncRNA gene predicted gene 12914
4 gene 81.934162 81.936148 positive MGI_C57BL6J_5826523 Gm46886 NCBI_Gene:108168998 MGI:5826523 lncRNA gene predicted gene, 46886
4 gene 82.033312 82.065890 negative MGI_C57BL6J_3649480 Gm11264 NCBI_Gene:102635575,ENSEMBL:ENSMUSG00000087110 MGI:3649480 lncRNA gene predicted gene 11264
4 gene 82.061112 82.061221 negative MGI_C57BL6J_5452179 Gm22402 ENSEMBL:ENSMUSG00000092661 MGI:5452179 miRNA gene predicted gene, 22402
4 gene 82.065380 82.102808 positive MGI_C57BL6J_3646172 Gm5860 NCBI_Gene:545641,ENSEMBL:ENSMUSG00000085022 MGI:3646172 lncRNA gene predicted gene 5860
4 gene 82.290173 82.705750 negative MGI_C57BL6J_103188 Nfib NCBI_Gene:18028,ENSEMBL:ENSMUSG00000008575 MGI:103188 protein coding gene nuclear factor I/B
4 gene 82.315587 82.319897 negative MGI_C57BL6J_2444640 D830012I16Rik NA NA unclassified gene RIKEN cDNA D830012I16 gene
4 gene 82.439410 82.439514 positive MGI_C57BL6J_4422053 n-R5s188 ENSEMBL:ENSMUSG00000084595 MGI:4422053 rRNA gene nuclear encoded rRNA 5S 188
4 gene 82.450058 82.458093 negative MGI_C57BL6J_1923705 2310067E19Rik NCBI_Gene:76455 MGI:1923705 unclassified gene RIKEN cDNA 2310067E19 gene
4 gene 82.508016 82.547295 positive MGI_C57BL6J_3649705 Gm11266 NCBI_Gene:102635783,ENSEMBL:ENSMUSG00000087413 MGI:3649705 lncRNA gene predicted gene 11266
4 gene 82.585048 82.587319 negative MGI_C57BL6J_3649847 Gm11267 ENSEMBL:ENSMUSG00000084851 MGI:3649847 lncRNA gene predicted gene 11267
4 gene 82.605505 82.606917 positive MGI_C57BL6J_5625190 Gm42305 NCBI_Gene:105247154 MGI:5625190 lncRNA gene predicted gene, 42305
4 gene 82.619623 82.619694 negative MGI_C57BL6J_4413900 n-THgtg10 NCBI_Gene:108169019 MGI:4413900 tRNA gene nuclear encoded tRNA histidine 10 (anticodon GTG)
4 pseudogene 82.642400 82.642666 positive MGI_C57BL6J_3649856 Gm11268 ENSEMBL:ENSMUSG00000084357 MGI:3649856 pseudogene predicted gene 11268
4 gene 82.691739 82.694876 positive MGI_C57BL6J_3649855 Gm11269 NCBI_Gene:102635985,ENSEMBL:ENSMUSG00000086293 MGI:3649855 lncRNA gene predicted gene 11269
4 gene 82.798738 82.859958 negative MGI_C57BL6J_1915518 Zdhhc21 NCBI_Gene:68268,ENSEMBL:ENSMUSG00000028403 MGI:1915518 protein coding gene zinc finger, DHHC domain containing 21
4 gene 82.881751 82.885151 negative MGI_C57BL6J_1201414 Cer1 NCBI_Gene:12622,ENSEMBL:ENSMUSG00000038192 MGI:1201414 protein coding gene cerberus 1, DAN family BMP antagonist
4 gene 82.897920 83.052406 negative MGI_C57BL6J_2670972 Frem1 NCBI_Gene:329872,ENSEMBL:ENSMUSG00000059049 MGI:2670972 protein coding gene Fras1 related extracellular matrix protein 1
4 gene 82.922313 82.940309 positive MGI_C57BL6J_5592419 Gm33260 NCBI_Gene:102636092 MGI:5592419 lncRNA gene predicted gene, 33260
4 gene 83.023799 83.024240 positive MGI_C57BL6J_1925414 4930441N18Rik NA NA unclassified gene RIKEN cDNA 4930441N18 gene
4 gene 83.078511 83.078629 positive MGI_C57BL6J_5454661 Gm24884 ENSEMBL:ENSMUSG00000089409 MGI:5454661 snoRNA gene predicted gene, 24884
4 pseudogene 83.121541 83.121741 positive MGI_C57BL6J_3651451 Gm11248 ENSEMBL:ENSMUSG00000082637 MGI:3651451 pseudogene predicted gene 11248
4 gene 83.178401 83.186545 negative MGI_C57BL6J_5826524 Gm46887 NCBI_Gene:108168999 MGI:5826524 lncRNA gene predicted gene, 46887
4 pseudogene 83.193970 83.195194 positive MGI_C57BL6J_3650877 Gm11185 NCBI_Gene:667985,ENSEMBL:ENSMUSG00000083245 MGI:3650877 pseudogene predicted gene 11185
4 gene 83.220300 83.324274 negative MGI_C57BL6J_1917113 Ttc39b NCBI_Gene:69863,ENSEMBL:ENSMUSG00000038172 MGI:1917113 protein coding gene tetratricopeptide repeat domain 39B
4 gene 83.283094 83.287822 positive MGI_C57BL6J_5625192 Gm42307 NCBI_Gene:105247156 MGI:5625192 lncRNA gene predicted gene, 42307
4 gene 83.285804 83.285910 negative MGI_C57BL6J_5453189 Gm23412 ENSEMBL:ENSMUSG00000096801 MGI:5453189 snRNA gene predicted gene, 23412
4 gene 83.324418 83.330554 positive MGI_C57BL6J_5625191 Gm42306 NCBI_Gene:105247155 MGI:5625191 lncRNA gene predicted gene, 42306
4 gene 83.378317 83.390668 negative MGI_C57BL6J_3650701 Gm11413 NCBI_Gene:790913,ENSEMBL:ENSMUSG00000086321 MGI:3650701 lncRNA gene predicted gene 11413
4 gene 83.382413 83.392316 positive MGI_C57BL6J_3651087 Gm11184 NCBI_Gene:102636232,ENSEMBL:ENSMUSG00000087592 MGI:3651087 lncRNA gene predicted gene 11184
4 gene 83.417700 83.473019 positive MGI_C57BL6J_1916338 Snapc3 NCBI_Gene:77634,ENSEMBL:ENSMUSG00000028483 MGI:1916338 protein coding gene small nuclear RNA activating complex, polypeptide 3
4 gene 83.455680 83.486512 negative MGI_C57BL6J_2142116 Psip1 NCBI_Gene:101739,ENSEMBL:ENSMUSG00000028484 MGI:2142116 protein coding gene PC4 and SFRS1 interacting protein 1
4 gene 83.471743 83.473018 positive MGI_C57BL6J_1925039 A930007D18Rik NA NA unclassified gene RIKEN cDNA A930007D18 gene
4 pseudogene 83.500499 83.500761 negative MGI_C57BL6J_3650503 Gm11414 ENSEMBL:ENSMUSG00000082416 MGI:3650503 pseudogene predicted gene 11414
4 pseudogene 83.505143 83.505571 negative MGI_C57BL6J_3642271 Gm10154 NCBI_Gene:100040611,ENSEMBL:ENSMUSG00000066116 MGI:3642271 pseudogene predicted gene 10154
4 gene 83.508280 83.511290 negative MGI_C57BL6J_5625193 Gm42308 NCBI_Gene:105247157 MGI:5625193 lncRNA gene predicted gene, 42308
4 gene 83.525400 83.866143 positive MGI_C57BL6J_1922152 Ccdc171 NCBI_Gene:320226,ENSEMBL:ENSMUSG00000052407 MGI:1922152 protein coding gene coiled-coil domain containing 171
4 gene 83.527628 83.527768 negative MGI_C57BL6J_5455676 Gm25899 ENSEMBL:ENSMUSG00000064606 MGI:5455676 snRNA gene predicted gene, 25899
4 pseudogene 83.597303 83.597765 positive MGI_C57BL6J_5504161 Gm27046 ENSEMBL:ENSMUSG00000098217 MGI:5504161 pseudogene predicted gene, 27046
4 pseudogene 83.611016 83.612219 negative MGI_C57BL6J_5010872 Gm18687 NCBI_Gene:100417557 MGI:5010872 pseudogene predicted gene, 18687
4 pseudogene 83.700980 83.704495 positive MGI_C57BL6J_1890540 Cbx3-ps3 NCBI_Gene:102641235,ENSEMBL:ENSMUSG00000080793 MGI:1890540 pseudogene chromobox 3, pseudogene 3
4 gene 83.743677 83.744157 positive MGI_C57BL6J_5504083 Gm26968 ENSEMBL:ENSMUSG00000097942 MGI:5504083 lncRNA gene predicted gene, 26968
4 gene 83.826128 83.842051 negative MGI_C57BL6J_5625194 Gm42309 NCBI_Gene:105247158 MGI:5625194 lncRNA gene predicted gene, 42309
4 gene 83.870422 83.888858 negative MGI_C57BL6J_3650502 Gm11415 NCBI_Gene:105247159,ENSEMBL:ENSMUSG00000085378 MGI:3650502 lncRNA gene predicted gene 11415
4 gene 84.042039 84.044879 negative MGI_C57BL6J_1925488 6030471H07Rik NCBI_Gene:78238,ENSEMBL:ENSMUSG00000085217 MGI:1925488 lncRNA gene RIKEN cDNA 6030471H07 gene
4 gene 84.072395 84.081923 negative MGI_C57BL6J_5592639 Gm33480 NCBI_Gene:102636405 MGI:5592639 lncRNA gene predicted gene, 33480
4 gene 84.072618 84.101430 positive MGI_C57BL6J_5592569 Gm33410 NCBI_Gene:102636305 MGI:5592569 lncRNA gene predicted gene, 33410
4 pseudogene 84.104877 84.106114 positive MGI_C57BL6J_3650588 Gm12416 NCBI_Gene:668010,ENSEMBL:ENSMUSG00000083044 MGI:3650588 pseudogene predicted gene 12416
4 gene 84.110347 84.113352 positive MGI_C57BL6J_5625195 Gm42310 NCBI_Gene:105247160 MGI:5625195 lncRNA gene predicted gene, 42310
4 gene 84.125734 84.131762 negative MGI_C57BL6J_3650374 Gm12414 NCBI_Gene:102636485,ENSEMBL:ENSMUSG00000087378 MGI:3650374 lncRNA gene predicted gene 12414
4 gene 84.133256 84.220733 negative MGI_C57BL6J_5592756 Gm33597 NCBI_Gene:102636567 MGI:5592756 lncRNA gene predicted gene, 33597
4 gene 84.266804 84.676354 negative MGI_C57BL6J_2443805 Bnc2 NCBI_Gene:242509,ENSEMBL:ENSMUSG00000028487 MGI:2443805 protein coding gene basonuclin 2
4 pseudogene 84.428818 84.429124 negative MGI_C57BL6J_3650591 Gm12421 ENSEMBL:ENSMUSG00000083743 MGI:3650591 pseudogene predicted gene 12421
4 pseudogene 84.697863 84.698939 positive MGI_C57BL6J_3652148 Gm12420 NCBI_Gene:624465,ENSEMBL:ENSMUSG00000081775 MGI:3652148 pseudogene predicted gene 12420
4 gene 84.741475 84.744515 positive MGI_C57BL6J_3650585 Gm12415 NCBI_Gene:105247161,ENSEMBL:ENSMUSG00000086413 MGI:3650585 lncRNA gene predicted gene 12415
4 gene 84.883510 85.131923 positive MGI_C57BL6J_2443104 Cntln NCBI_Gene:338349,ENSEMBL:ENSMUSG00000038070 MGI:2443104 protein coding gene centlein, centrosomal protein
4 pseudogene 84.915835 84.917754 positive MGI_C57BL6J_3650582 Gm12418 NCBI_Gene:622811,ENSEMBL:ENSMUSG00000083139 MGI:3650582 pseudogene predicted gene 12418
4 pseudogene 84.923545 84.924198 negative MGI_C57BL6J_3650581 Gm12419 NCBI_Gene:100417804,ENSEMBL:ENSMUSG00000080303 MGI:3650581 pseudogene predicted gene 12419
4 pseudogene 85.176526 85.177026 negative MGI_C57BL6J_3780870 Gm2700 NCBI_Gene:100040303 MGI:3780870 pseudogene predicted gene 2700
4 pseudogene 85.176527 85.176929 positive MGI_C57BL6J_3650587 Gm12417 ENSEMBL:ENSMUSG00000084267 MGI:3650587 pseudogene predicted gene 12417
4 gene 85.205126 85.639195 positive MGI_C57BL6J_700009 Sh3gl2 NCBI_Gene:20404,ENSEMBL:ENSMUSG00000028488 MGI:700009 protein coding gene SH3-domain GRB2-like 2
4 pseudogene 85.245451 85.246193 negative MGI_C57BL6J_3650373 Gm12413 NCBI_Gene:100416925,ENSEMBL:ENSMUSG00000081862 MGI:3650373 pseudogene predicted gene 12413
4 gene 85.513234 86.428390 positive MGI_C57BL6J_1924989 Adamtsl1 NCBI_Gene:77739,ENSEMBL:ENSMUSG00000066113 MGI:1924989 protein coding gene ADAMTS-like 1
4 gene 85.514327 85.783129 positive MGI_C57BL6J_3650846 Gm12680 NA NA unclassified non-coding RNA gene predicted gene 12680
4 gene 85.909911 85.910187 positive MGI_C57BL6J_5455846 Gm26069 ENSEMBL:ENSMUSG00000088122 MGI:5455846 unclassified non-coding RNA gene predicted gene, 26069
4 pseudogene 85.921109 85.921944 negative MGI_C57BL6J_3779825 Gm8949 NCBI_Gene:668052 MGI:3779825 pseudogene predicted gene 8949
4 gene 86.043394 86.043494 negative MGI_C57BL6J_5455588 Gm25811 ENSEMBL:ENSMUSG00000064687 MGI:5455588 snRNA gene predicted gene, 25811
4 gene 86.421254 86.440949 negative MGI_C57BL6J_5592889 Gm33730 NCBI_Gene:102636740 MGI:5592889 lncRNA gene predicted gene, 33730
4 pseudogene 86.442013 86.442341 negative MGI_C57BL6J_3651460 Gm12550 ENSEMBL:ENSMUSG00000083272 MGI:3651460 pseudogene predicted gene 12550
4 gene 86.444425 86.558328 negative MGI_C57BL6J_1923061 Saxo1 NCBI_Gene:75811,ENSEMBL:ENSMUSG00000028492 MGI:1923061 protein coding gene stabilizer of axonemal microtubules 1
4 gene 86.509152 86.509225 positive MGI_C57BL6J_5455794 Gm26017 ENSEMBL:ENSMUSG00000077597 MGI:5455794 snRNA gene predicted gene, 26017
4 gene 86.558444 86.559804 positive MGI_C57BL6J_1922138 Saxo1os NCBI_Gene:74888,ENSEMBL:ENSMUSG00000085108 MGI:1922138 antisense lncRNA gene stabilizer of axonemal microtubules 1, opposite strand
4 gene 86.575668 86.577285 positive MGI_C57BL6J_1915691 Rraga NCBI_Gene:68441,ENSEMBL:ENSMUSG00000070934 MGI:1915691 protein coding gene Ras-related GTP binding A
4 gene 86.578855 86.612075 negative MGI_C57BL6J_1923389 Haus6 NCBI_Gene:230376,ENSEMBL:ENSMUSG00000038047 MGI:1923389 protein coding gene HAUS augmin-like complex, subunit 6
4 gene 86.586453 86.586583 negative MGI_C57BL6J_3819488 Scarna8 NCBI_Gene:100217448,ENSEMBL:ENSMUSG00000088958 MGI:3819488 snoRNA gene small Cajal body-specific RNA 8
4 pseudogene 86.626854 86.633209 negative MGI_C57BL6J_3651664 Gm12551 NCBI_Gene:101055843,ENSEMBL:ENSMUSG00000081169 MGI:3651664 pseudogene predicted gene 12551
4 gene 86.626910 86.670060 negative MGI_C57BL6J_87920 Plin2 NCBI_Gene:11520,ENSEMBL:ENSMUSG00000028494 MGI:87920 protein coding gene perilipin 2
4 gene 86.710969 86.743814 positive MGI_C57BL6J_5625197 Gm42312 NCBI_Gene:105247163 MGI:5625197 lncRNA gene predicted gene, 42312
4 gene 86.747529 86.749458 negative MGI_C57BL6J_3645185 Gm6521 NA NA unclassified gene predicted gene 6521
4 gene 86.748398 86.850603 positive MGI_C57BL6J_1914769 Dennd4c NCBI_Gene:329877,ENSEMBL:ENSMUSG00000038024 MGI:1914769 protein coding gene DENN/MADD domain containing 4C
4 gene 86.768488 86.769803 positive MGI_C57BL6J_1921836 4833420L08Rik NA NA unclassified gene RIKEN cDNA 4833420L08 gene
4 pseudogene 86.817752 86.818603 negative MGI_C57BL6J_3650968 Gm12630 NCBI_Gene:100384871,ENSEMBL:ENSMUSG00000082969 MGI:3650968 pseudogene predicted gene 12630
4 gene 86.854099 86.857412 negative MGI_C57BL6J_98159 Rps6 NCBI_Gene:20104,ENSEMBL:ENSMUSG00000028495 MGI:98159 protein coding gene ribosomal protein S6
4 gene 86.874340 86.934822 positive MGI_C57BL6J_1920932 Acer2 NCBI_Gene:230379,ENSEMBL:ENSMUSG00000038007 MGI:1920932 protein coding gene alkaline ceramidase 2
4 gene 86.983124 87.230550 negative MGI_C57BL6J_1923626 Slc24a2 NCBI_Gene:76376,ENSEMBL:ENSMUSG00000037996 MGI:1923626 protein coding gene solute carrier family 24 (sodium/potassium/calcium exchanger), member 2
4 gene 87.023852 87.025645 negative MGI_C57BL6J_1925538 5330421F21Rik NA NA unclassified gene RIKEN cDNA 5330421F21 gene
4 pseudogene 87.100404 87.104926 positive MGI_C57BL6J_5593198 Gm34039 NCBI_Gene:108168966 MGI:5593198 pseudogene predicted gene, 34039
4 gene 87.298362 87.301270 positive MGI_C57BL6J_3651471 Gm12600 ENSEMBL:ENSMUSG00000086512 MGI:3651471 lncRNA gene predicted gene 12600
4 gene 87.432272 87.432336 positive MGI_C57BL6J_5452931 Gm23154 ENSEMBL:ENSMUSG00000093065 MGI:5452931 miRNA gene predicted gene, 23154
4 gene 87.530893 87.668521 negative MGI_C57BL6J_5593339 Gm34180 NCBI_Gene:102637345 MGI:5593339 lncRNA gene predicted gene, 34180
4 pseudogene 87.580780 87.581560 positive MGI_C57BL6J_3651368 Gm12604 NCBI_Gene:100418044,ENSEMBL:ENSMUSG00000082443 MGI:3651368 pseudogene predicted gene 12604
4 gene 87.769925 88.033407 negative MGI_C57BL6J_1917372 Mllt3 NCBI_Gene:70122,ENSEMBL:ENSMUSG00000028496 MGI:1917372 protein coding gene myeloid/lymphoid or mixed-lineage leukemia, translocated to, 3
4 gene 87.797092 87.798690 negative MGI_C57BL6J_1924111 4832441B07Rik NA NA unclassified gene RIKEN cDNA 4832441B07 gene
4 gene 87.974620 87.985631 negative MGI_C57BL6J_5593391 Gm34232 NCBI_Gene:102637422 MGI:5593391 lncRNA gene predicted gene, 34232
4 gene 88.033501 88.034998 positive MGI_C57BL6J_3650969 Gm12631 ENSEMBL:ENSMUSG00000084809 MGI:3650969 lncRNA gene predicted gene 12631
4 pseudogene 88.043804 88.044041 positive MGI_C57BL6J_3649679 Gm12646 ENSEMBL:ENSMUSG00000081530 MGI:3649679 pseudogene predicted gene 12646
4 gene 88.094629 88.411011 positive MGI_C57BL6J_2676921 Focad NCBI_Gene:230393,ENSEMBL:ENSMUSG00000038368 MGI:2676921 protein coding gene focadhesin
4 gene 88.122040 88.122125 positive MGI_C57BL6J_3629651 Mir491 miRBase:MI0004680,NCBI_Gene:735282,ENSEMBL:ENSMUSG00000070077 MGI:3629651 miRNA gene microRNA 491
4 pseudogene 88.151696 88.151970 positive MGI_C57BL6J_3649678 Gm12645 ENSEMBL:ENSMUSG00000082597 MGI:3649678 pseudogene predicted gene 12645
4 gene 88.396144 88.438936 negative MGI_C57BL6J_1914025 Hacd4 NCBI_Gene:66775,ENSEMBL:ENSMUSG00000028497 MGI:1914025 protein coding gene 3-hydroxyacyl-CoA dehydratase 4
4 gene 88.431730 88.432927 negative MGI_C57BL6J_1337997 Gdap6 NA NA unclassified gene ganglioside-induced differentiation-associated-protein 6
4 gene 88.522025 88.522794 negative MGI_C57BL6J_107657 Ifnb1 NCBI_Gene:15977,ENSEMBL:ENSMUSG00000048806 MGI:107657 protein coding gene interferon beta 1, fibroblast
4 gene 88.557673 88.558245 negative MGI_C57BL6J_3649418 Ifna15 NCBI_Gene:242517,ENSEMBL:ENSMUSG00000096011 MGI:3649418 protein coding gene interferon alpha 15
4 gene 88.571229 88.571798 negative MGI_C57BL6J_3641425 Ifna14 NCBI_Gene:404549,ENSEMBL:ENSMUSG00000095896 MGI:3641425 protein coding gene interferon alpha 14
4 pseudogene 88.578887 88.580574 negative MGI_C57BL6J_107669 Ifna-ps1 NCBI_Gene:100416153,ENSEMBL:ENSMUSG00000080964 MGI:107669 pseudogene interferon alpha gene, pseudogene 1
4 gene 88.591813 88.592385 negative MGI_C57BL6J_107659 Ifna9 NCBI_Gene:15972,ENSEMBL:ENSMUSG00000095270 MGI:107659 protein coding gene interferon alpha 9
4 pseudogene 88.598984 88.599875 negative MGI_C57BL6J_3050089 Mrpl48-ps NCBI_Gene:269553,ENSEMBL:ENSMUSG00000078480 MGI:3050089 pseudogene mitochondrial ribosomal protein L48 pseudogene
4 gene 88.602580 88.603376 negative MGI_C57BL6J_2676324 Ifna12 NCBI_Gene:242519,ENSEMBL:ENSMUSG00000073811 MGI:2676324 protein coding gene interferon alpha 12
4 pseudogene 88.612653 88.614044 negative MGI_C57BL6J_3650053 Gm12601 ENSEMBL:ENSMUSG00000083958 MGI:3650053 pseudogene predicted gene 12601
4 gene 88.627320 88.634411 negative MGI_C57BL6J_2140706 C87499 NCBI_Gene:381590,ENSEMBL:ENSMUSG00000038330 MGI:2140706 protein coding gene expressed sequence C87499
4 gene 88.643641 88.644459 negative MGI_C57BL6J_2667155 Ifna13 NCBI_Gene:230396,ENSEMBL:ENSMUSG00000063376 MGI:2667155 protein coding gene interferon alpha 13
4 pseudogene 88.648586 88.649365 negative MGI_C57BL6J_3649513 Gm13281 NCBI_Gene:546834,ENSEMBL:ENSMUSG00000081784 MGI:3649513 pseudogene predicted gene 13281
4 gene 88.675915 88.676924 negative MGI_C57BL6J_3649260 Ifna16 NCBI_Gene:230398,ENSEMBL:ENSMUSG00000078355 MGI:3649260 protein coding gene interferon alpha 16
4 gene 88.682881 88.683912 negative MGI_C57BL6J_107666 Ifna2 NCBI_Gene:15965,ENSEMBL:ENSMUSG00000078354 MGI:107666 protein coding gene interferon alpha 2
4 gene 88.690302 88.691359 negative MGI_C57BL6J_1097683 Ifnab NCBI_Gene:15974,ENSEMBL:ENSMUSG00000100079 MGI:1097683 protein coding gene interferon alpha B
4 pseudogene 88.696191 88.696698 negative MGI_C57BL6J_3650885 Gm13273 ENSEMBL:ENSMUSG00000081893 MGI:3650885 pseudogene predicted gene 13273
4 pseudogene 88.707892 88.708454 negative MGI_C57BL6J_3649258 Gm13282 NCBI_Gene:546835,ENSEMBL:ENSMUSG00000084192 MGI:3649258 pseudogene predicted gene 13282
4 gene 88.718292 88.722508 negative MGI_C57BL6J_2180122 Klhl9 NCBI_Gene:242521,ENSEMBL:ENSMUSG00000070923 MGI:2180122 protein coding gene kelch-like 9
4 gene 88.721805 88.722842 positive MGI_C57BL6J_5477060 Gm26566 ENSEMBL:ENSMUSG00000097078 MGI:5477060 protein coding gene predicted gene, 26566
4 gene 88.722757 88.757579 negative MGI_C57BL6J_3649443 Gm13274 NCBI_Gene:100037413,ENSEMBL:ENSMUSG00000086074 MGI:3649443 lncRNA gene predicted gene 13274
4 pseudogene 88.754471 88.754678 positive MGI_C57BL6J_6270567 Gm49884 ENSEMBL:ENSMUSG00000117268 MGI:6270567 pseudogene predicted gene, 49884
4 gene 88.754868 88.755416 positive MGI_C57BL6J_3701966 Gm13271 NCBI_Gene:435791,ENSEMBL:ENSMUSG00000094618 MGI:3701966 protein coding gene predicted gene 13271
4 pseudogene 88.757844 88.758392 positive MGI_C57BL6J_3650855 Gm13286 NCBI_Gene:100041062,ENSEMBL:ENSMUSG00000081501 MGI:3650855 pseudogene predicted gene 13286
4 pseudogene 88.758171 88.758570 negative MGI_C57BL6J_3708693 Gm10583 ENSEMBL:ENSMUSG00000073809 MGI:3708693 pseudogene predicted gene 10583
4 gene 88.760119 88.761584 positive MGI_C57BL6J_3649573 Gm13283 NCBI_Gene:545645,ENSEMBL:ENSMUSG00000100505 MGI:3649573 protein coding gene predicted gene 13283
4 pseudogene 88.761101 88.761500 negative MGI_C57BL6J_3708694 Gm10582 ENSEMBL:ENSMUSG00000094498 MGI:3708694 pseudogene predicted gene 10582
4 pseudogene 88.763054 88.771864 positive MGI_C57BL6J_3701980 Gm13284 NCBI_Gene:668147,ENSEMBL:ENSMUSG00000082789 MGI:3701980 pseudogene predicted gene 13284
4 pseudogene 88.771550 88.771784 negative MGI_C57BL6J_3708695 Gm10581 ENSEMBL:ENSMUSG00000073807 MGI:3708695 pseudogene predicted gene 10581
4 gene 88.773834 88.774801 positive MGI_C57BL6J_3701990 Gm13290 NCBI_Gene:545646,ENSEMBL:ENSMUSG00000094271 MGI:3701990 protein coding gene predicted gene 13290
4 pseudogene 88.774321 88.774720 negative MGI_C57BL6J_3708696 Gm10580 ENSEMBL:ENSMUSG00000094167 MGI:3708696 pseudogene predicted gene 10580
4 gene 88.776762 88.777729 positive MGI_C57BL6J_3701987 Gm13289 NCBI_Gene:545647,ENSEMBL:ENSMUSG00000096582 MGI:3701987 protein coding gene predicted gene 13289
4 gene 88.779850 88.780660 positive MGI_C57BL6J_3701968 Gm13272 NCBI_Gene:545648,ENSEMBL:ENSMUSG00000096591 MGI:3701968 protein coding gene predicted gene 13272
4 gene 88.782131 88.783592 positive MGI_C57BL6J_2448469 Ifnz NCBI_Gene:319146,ENSEMBL:ENSMUSG00000096854 MGI:2448469 protein coding gene interferon zeta
4 gene 88.784455 88.794391 negative MGI_C57BL6J_5477019 Gm26525 ENSEMBL:ENSMUSG00000096987 MGI:5477019 lncRNA gene predicted gene, 26525
4 gene 88.785054 88.786515 positive MGI_C57BL6J_3701972 Gm13276 NCBI_Gene:545649,ENSEMBL:ENSMUSG00000099545 MGI:3701972 protein coding gene predicted gene 13276
4 gene 88.787977 88.789438 positive MGI_C57BL6J_3701974 Gm13277 NCBI_Gene:545650,ENSEMBL:ENSMUSG00000100234 MGI:3701974 protein coding gene predicted gene 13277
4 gene 88.790895 88.792356 positive MGI_C57BL6J_3701976 Gm13278 NCBI_Gene:545651,ENSEMBL:ENSMUSG00000101163 MGI:3701976 protein coding gene predicted gene 13278
4 gene 88.793742 88.795297 positive MGI_C57BL6J_3701970 Gm13275 NCBI_Gene:545652,ENSEMBL:ENSMUSG00000099518 MGI:3701970 protein coding gene predicted gene 13275
4 gene 88.796143 88.800224 negative MGI_C57BL6J_5477361 Gm26867 ENSEMBL:ENSMUSG00000097873 MGI:5477361 lncRNA gene predicted gene, 26867
4 gene 88.797237 88.798204 positive MGI_C57BL6J_3701978 Gm13279 NCBI_Gene:545653,ENSEMBL:ENSMUSG00000099420 MGI:3701978 protein coding gene predicted gene 13279
4 gene 88.799665 88.801126 positive MGI_C57BL6J_3701981 Gm13285 NCBI_Gene:545654,ENSEMBL:ENSMUSG00000095101 MGI:3701981 protein coding gene predicted gene 13285
4 gene 88.803254 88.803802 positive MGI_C57BL6J_3701983 Gm13287 NCBI_Gene:545655,ENSEMBL:ENSMUSG00000094648 MGI:3701983 protein coding gene predicted gene 13287
4 gene 88.805531 88.808380 positive MGI_C57BL6J_3701985 Gm13288 NCBI_Gene:668208,ENSEMBL:ENSMUSG00000070908 MGI:3701985 protein coding gene predicted gene 13288
4 gene 88.816225 88.816800 positive MGI_C57BL6J_107661 Ifna7 NCBI_Gene:15970,ENSEMBL:ENSMUSG00000100713 MGI:107661 protein coding gene interferon alpha 7
4 gene 88.819919 88.820565 positive MGI_C57BL6J_109210 Ifna11 NCBI_Gene:15964,ENSEMBL:ENSMUSG00000100549 MGI:109210 protein coding gene interferon alpha 11
4 gene 88.827416 88.827985 positive MGI_C57BL6J_107662 Ifna6 NCBI_Gene:15969,ENSEMBL:ENSMUSG00000101252 MGI:107662 protein coding gene interferon alpha 6
4 gene 88.835525 88.836094 positive MGI_C57BL6J_107663 Ifna5 NCBI_Gene:15968,ENSEMBL:ENSMUSG00000096682 MGI:107663 protein coding gene interferon alpha 5
4 gene 88.841816 88.842459 positive MGI_C57BL6J_107664 Ifna4 NCBI_Gene:15967,ENSEMBL:ENSMUSG00000070904 MGI:107664 protein coding gene interferon alpha 4
4 gene 88.850087 88.850656 positive MGI_C57BL6J_107668 Ifna1 NCBI_Gene:15962,ENSEMBL:ENSMUSG00000095498 MGI:107668 protein coding gene interferon alpha 1
4 gene 88.867233 88.868380 negative MGI_C57BL6J_1922496 4930553M12Rik ENSEMBL:ENSMUSG00000054351 MGI:1922496 lncRNA gene RIKEN cDNA 4930553M12 gene
4 gene 88.871741 88.874895 positive MGI_C57BL6J_5593616 Gm34457 NCBI_Gene:102637717 MGI:5593616 lncRNA gene predicted gene, 34457
4 gene 88.879538 88.880201 negative MGI_C57BL6J_2667156 Ifne NCBI_Gene:230405,ENSEMBL:ENSMUSG00000045364 MGI:2667156 protein coding gene interferon epsilon
4 gene 88.909855 88.938521 negative MGI_C57BL6J_6270578 Gm49890 ENSEMBL:ENSMUSG00000117123 MGI:6270578 lncRNA gene predicted gene, 49890
4 gene 88.910557 88.910662 negative MGI_C57BL6J_3619330 Mir31 miRBase:MI0000579,NCBI_Gene:723895,ENSEMBL:ENSMUSG00000065408 MGI:3619330 miRNA gene microRNA 31
4 gene 88.956416 89.031301 positive MGI_C57BL6J_5593727 Gm34568 NCBI_Gene:102637866 MGI:5593727 lncRNA gene predicted gene, 34568
4 gene 88.995118 89.039192 negative MGI_C57BL6J_6270580 Gm49891 ENSEMBL:ENSMUSG00000117251 MGI:6270580 lncRNA gene predicted gene, 49891
4 gene 89.050307 89.084614 positive MGI_C57BL6J_3649757 Wincr1 NCBI_Gene:100040617,ENSEMBL:ENSMUSG00000085183 MGI:3649757 lncRNA gene WNT induced non-coding RNA 1
4 gene 89.099866 89.128761 negative MGI_C57BL6J_3651757 Gm12602 NCBI_Gene:102637941,ENSEMBL:ENSMUSG00000085569 MGI:3651757 lncRNA gene predicted gene 12602
4 gene 89.137122 89.181090 positive MGI_C57BL6J_1914152 Mtap NCBI_Gene:66902,ENSEMBL:ENSMUSG00000062937 MGI:1914152 protein coding gene methylthioadenosine phosphorylase
4 pseudogene 89.161699 89.162218 negative MGI_C57BL6J_3649224 Gm12607 NCBI_Gene:100416402,ENSEMBL:ENSMUSG00000083989 MGI:3649224 pseudogene predicted gene 12607
4 gene 89.182981 89.183120 negative MGI_C57BL6J_5456267 Gm26490 ENSEMBL:ENSMUSG00000088504 MGI:5456267 snoRNA gene predicted gene, 26490
4 pseudogene 89.216711 89.218488 positive MGI_C57BL6J_3649223 Tgif2-ps1 NCBI_Gene:625574,ENSEMBL:ENSMUSG00000107513 MGI:3649223 pseudogene TGFB-induced factor homeobox 2, pseudogene 1
4 gene 89.235699 89.273403 negative MGI_C57BL6J_3649222 Gm12606 ENSEMBL:ENSMUSG00000087659 MGI:3649222 lncRNA gene predicted gene 12606
4 gene 89.274471 89.294653 negative MGI_C57BL6J_104738 Cdkn2a NCBI_Gene:12578,ENSEMBL:ENSMUSG00000044303 MGI:104738 protein coding gene cyclin dependent kinase inhibitor 2A
4 gene 89.295180 89.518621 positive MGI_C57BL6J_3652143 Gm12610 NCBI_Gene:102633081,ENSEMBL:ENSMUSG00000086035 MGI:3652143 lncRNA gene predicted gene 12610
4 gene 89.306289 89.311039 negative MGI_C57BL6J_104737 Cdkn2b NCBI_Gene:12579,ENSEMBL:ENSMUSG00000073802 MGI:104737 protein coding gene cyclin dependent kinase inhibitor 2B
4 gene 89.381957 89.399880 positive MGI_C57BL6J_3652142 Gm12609 ENSEMBL:ENSMUSG00000085147 MGI:3652142 lncRNA gene predicted gene 12609
4 pseudogene 89.442217 89.444644 negative MGI_C57BL6J_3652144 Gm12608 NCBI_Gene:664785,ENSEMBL:ENSMUSG00000080808 MGI:3652144 pseudogene predicted gene 12608
4 gene 89.445219 89.445367 positive MGI_C57BL6J_5530962 Gm27580 ENSEMBL:ENSMUSG00000098669 MGI:5530962 unclassified non-coding RNA gene predicted gene, 27580
4 gene 89.679436 89.694772 positive MGI_C57BL6J_2653627 Dmrta1 NCBI_Gene:242523,ENSEMBL:ENSMUSG00000043753 MGI:2653627 protein coding gene doublesex and mab-3 related transcription factor like family A1
4 gene 90.185527 90.190009 positive MGI_C57BL6J_3650349 Gm12629 ENSEMBL:ENSMUSG00000085690 MGI:3650349 lncRNA gene predicted gene 12629
4 gene 90.218820 90.225702 positive MGI_C57BL6J_2387418 Zfp352 NCBI_Gene:236537,ENSEMBL:ENSMUSG00000070902 MGI:2387418 protein coding gene zinc finger protein 352
4 pseudogene 90.359622 90.361326 negative MGI_C57BL6J_3650768 Gm12633 NCBI_Gene:619842,ENSEMBL:ENSMUSG00000080756 MGI:3650768 pseudogene predicted gene 12633
4 pseudogene 90.368713 90.369907 positive MGI_C57BL6J_3650769 Gm12634 NCBI_Gene:435792,ENSEMBL:ENSMUSG00000082569 MGI:3650769 pseudogene predicted gene 12634
4 pseudogene 90.452207 90.453625 positive MGI_C57BL6J_3650766 Gm12635 NCBI_Gene:100417247,ENSEMBL:ENSMUSG00000081563 MGI:3650766 pseudogene predicted gene 12635
4 pseudogene 90.543738 90.544382 negative MGI_C57BL6J_3650767 Gm12636 NCBI_Gene:100417387,ENSEMBL:ENSMUSG00000082502 MGI:3650767 pseudogene predicted gene 12636
4 pseudogene 90.856839 90.857575 positive MGI_C57BL6J_3650967 Gm12632 NCBI_Gene:606536,ENSEMBL:ENSMUSG00000082622 MGI:3650967 pseudogene predicted gene 12632
4 gene 90.997862 90.997993 negative MGI_C57BL6J_5455021 Gm25244 ENSEMBL:ENSMUSG00000096896 MGI:5455021 snoRNA gene predicted gene, 25244
4 pseudogene 91.037884 91.038273 positive MGI_C57BL6J_3649676 Gm12643 NCBI_Gene:108169000,ENSEMBL:ENSMUSG00000079962 MGI:3649676 pseudogene predicted gene 12643
4 pseudogene 91.156665 91.157739 positive MGI_C57BL6J_3649677 Gm12644 NCBI_Gene:664848,ENSEMBL:ENSMUSG00000081876 MGI:3649677 pseudogene predicted gene 12644
4 gene 91.211532 91.246042 negative MGI_C57BL6J_2443380 A730080H06Rik NCBI_Gene:102633497 MGI:2443380 lncRNA gene RIKEN cDNA A730080H06 gene
4 gene 91.250763 91.400785 negative MGI_C57BL6J_1100887 Elavl2 NCBI_Gene:15569,ENSEMBL:ENSMUSG00000008489 MGI:1100887 protein coding gene ELAV like RNA binding protein 1
4 pseudogene 91.365379 91.365939 positive MGI_C57BL6J_3650062 Gm12653 NCBI_Gene:100418436,ENSEMBL:ENSMUSG00000083377 MGI:3650062 pseudogene predicted gene 12653
4 gene 91.373284 91.373363 negative MGI_C57BL6J_5531146 Mir6402 miRBase:MI0021938,NCBI_Gene:102466157,ENSEMBL:ENSMUSG00000098563 MGI:5531146 miRNA gene microRNA 6402
4 gene 91.496622 91.536487 positive MGI_C57BL6J_5623087 Gm40202 NCBI_Gene:105244619 MGI:5623087 lncRNA gene predicted gene, 40202
4 gene 91.626589 91.630139 positive MGI_C57BL6J_3651936 Gm12668 ENSEMBL:ENSMUSG00000085817 MGI:3651936 lncRNA gene predicted gene 12668
4 gene 91.646315 91.651152 positive MGI_C57BL6J_3651682 Gm12670 ENSEMBL:ENSMUSG00000086042 MGI:3651682 lncRNA gene predicted gene 12670
4 pseudogene 91.708629 91.709969 positive MGI_C57BL6J_3651935 Gm12667 NCBI_Gene:100417505,ENSEMBL:ENSMUSG00000082523 MGI:3651935 pseudogene predicted gene 12667
4 pseudogene 91.805547 91.806555 negative MGI_C57BL6J_3651683 Gm12669 NCBI_Gene:620016,ENSEMBL:ENSMUSG00000100863 MGI:3651683 pseudogene predicted gene 12669
4 pseudogene 91.851487 91.852687 negative MGI_C57BL6J_3651684 Gm12671 NCBI_Gene:654475,ENSEMBL:ENSMUSG00000095937 MGI:3651684 pseudogene predicted gene 12671
4 gene 91.938854 91.939952 negative MGI_C57BL6J_1925473 4930577H14Rik ENSEMBL:ENSMUSG00000087517 MGI:1925473 lncRNA gene RIKEN cDNA 4930577H14 gene
4 gene 92.144318 92.147234 negative MGI_C57BL6J_1916564 Izumo3 NCBI_Gene:69314,ENSEMBL:ENSMUSG00000028533 MGI:1916564 protein coding gene IZUMO family member 3
4 gene 92.147281 92.150948 positive MGI_C57BL6J_5623088 Gm40203 NCBI_Gene:105244620 MGI:5623088 lncRNA gene predicted gene, 40203
4 gene 92.190685 92.191749 negative MGI_C57BL6J_3650864 Gm12666 NCBI_Gene:68280,ENSEMBL:ENSMUSG00000066107 MGI:3650864 protein coding gene predicted gene 12666
4 gene 92.241764 92.266240 positive MGI_C57BL6J_5623089 Gm40204 NCBI_Gene:105244621 MGI:5623089 lncRNA gene predicted gene, 40204
4 pseudogene 92.373051 92.373348 negative MGI_C57BL6J_3650765 Gm12638 NCBI_Gene:100502690,ENSEMBL:ENSMUSG00000083296 MGI:3650765 pseudogene predicted gene 12638
4 gene 92.484613 92.548826 positive MGI_C57BL6J_3650764 Gm12637 NCBI_Gene:108169002,ENSEMBL:ENSMUSG00000085209 MGI:3650764 lncRNA gene predicted gene 12637
4 gene 92.866475 92.866582 negative MGI_C57BL6J_5452382 Gm22605 ENSEMBL:ENSMUSG00000088914 MGI:5452382 snRNA gene predicted gene, 22605
4 pseudogene 92.970244 92.970736 negative MGI_C57BL6J_3649270 Gm12639 ENSEMBL:ENSMUSG00000081987 MGI:3649270 pseudogene predicted gene 12639
4 pseudogene 93.106967 93.110117 positive MGI_C57BL6J_3649567 Gm12641 NCBI_Gene:620269,ENSEMBL:ENSMUSG00000082919 MGI:3649567 pseudogene predicted gene 12641
4 pseudogene 93.265413 93.266288 negative MGI_C57BL6J_3649275 Gm12642 NCBI_Gene:384125,ENSEMBL:ENSMUSG00000082325 MGI:3649275 pseudogene predicted gene 12642
4 gene 93.334138 93.335511 negative MGI_C57BL6J_2684283 Tusc1 NCBI_Gene:69136,ENSEMBL:ENSMUSG00000054000 MGI:2684283 protein coding gene tumor suppressor candidate 1
4 gene 93.370406 93.481395 negative MGI_C57BL6J_5590987 Gm31828 NCBI_Gene:102634183 MGI:5590987 lncRNA gene predicted gene, 31828
4 gene 93.453258 93.671070 negative MGI_C57BL6J_3649947 Gm12649 ENSEMBL:ENSMUSG00000084833 MGI:3649947 lncRNA gene predicted gene 12649
4 gene 93.545150 93.545277 negative MGI_C57BL6J_5453220 Gm23443 ENSEMBL:ENSMUSG00000064850 MGI:5453220 snoRNA gene predicted gene, 23443
4 pseudogene 93.599186 93.599495 positive MGI_C57BL6J_3649267 Gm12640 ENSEMBL:ENSMUSG00000083607 MGI:3649267 pseudogene predicted gene 12640
4 gene 93.600979 93.601085 positive MGI_C57BL6J_5454573 Gm24796 ENSEMBL:ENSMUSG00000095898 MGI:5454573 snRNA gene predicted gene, 24796
4 gene 93.745888 93.745997 negative MGI_C57BL6J_5452396 Gm22619 ENSEMBL:ENSMUSG00000095856 MGI:5452396 miRNA gene predicted gene, 22619
4 pseudogene 93.802333 93.802622 positive MGI_C57BL6J_3649946 Gm12650 NCBI_Gene:102634336,ENSEMBL:ENSMUSG00000073797 MGI:3649946 pseudogene predicted gene 12650
4 gene 93.830417 93.864235 negative MGI_C57BL6J_5591194 Gm32035 NCBI_Gene:102634455 MGI:5591194 lncRNA gene predicted gene, 32035
4 pseudogene 94.061141 94.061649 positive MGI_C57BL6J_3649949 Gm12647 NCBI_Gene:100417559,ENSEMBL:ENSMUSG00000081685 MGI:3649949 pseudogene predicted gene 12647
4 gene 94.088138 94.425588 negative MGI_C57BL6J_3649948 Gm12648 NCBI_Gene:108168967,ENSEMBL:ENSMUSG00000085931 MGI:3649948 lncRNA gene predicted gene 12648
4 gene 94.098290 94.098418 positive MGI_C57BL6J_5453613 Gm23836 ENSEMBL:ENSMUSG00000077622 MGI:5453613 snoRNA gene predicted gene, 23836
4 pseudogene 94.104039 94.104837 negative MGI_C57BL6J_5010190 Gm18005 NCBI_Gene:100416254 MGI:5010190 pseudogene predicted gene, 18005
4 pseudogene 94.395618 94.396244 positive MGI_C57BL6J_3651710 Gm12654 NCBI_Gene:100416259,ENSEMBL:ENSMUSG00000081508 MGI:3651710 pseudogene predicted gene 12654
4 gene 94.434224 94.434484 negative MGI_C57BL6J_5456187 Gm26410 ENSEMBL:ENSMUSG00000088295 MGI:5456187 unclassified non-coding RNA gene predicted gene, 26410
4 gene 94.460277 94.557076 negative MGI_C57BL6J_1915020 Caap1 NCBI_Gene:67770,ENSEMBL:ENSMUSG00000028578 MGI:1915020 protein coding gene caspase activity and apoptosis inhibitor 1
4 gene 94.460931 94.477180 negative MGI_C57BL6J_3651648 Gm12655 ENSEMBL:ENSMUSG00000087128 MGI:3651648 lncRNA gene predicted gene 12655
4 gene 94.487883 94.487983 positive MGI_C57BL6J_5452581 Gm22804 ENSEMBL:ENSMUSG00000088677 MGI:5452581 snoRNA gene predicted gene, 22804
4 pseudogene 94.496989 94.497608 positive MGI_C57BL6J_3651715 Gm12656 NCBI_Gene:100418440,ENSEMBL:ENSMUSG00000083359 MGI:3651715 pseudogene predicted gene 12656
4 gene 94.556546 94.557078 positive MGI_C57BL6J_3704234 Gm10306 NA NA protein coding gene predicted gene 10306
4 gene 94.565139 94.603247 negative MGI_C57BL6J_104810 Plaa NCBI_Gene:18786,ENSEMBL:ENSMUSG00000028577 MGI:104810 protein coding gene phospholipase A2, activating protein
4 pseudogene 94.593650 94.600319 positive MGI_C57BL6J_3651714 Gm12657 NCBI_Gene:667250,ENSEMBL:ENSMUSG00000063314 MGI:3651714 pseudogene predicted gene 12657
4 gene 94.603261 94.693233 positive MGI_C57BL6J_1914944 Ift74 NCBI_Gene:67694,ENSEMBL:ENSMUSG00000028576 MGI:1914944 protein coding gene intraflagellar transport 74
4 gene 94.636653 94.650144 negative MGI_C57BL6J_2140219 Lrrc19 NCBI_Gene:100061,ENSEMBL:ENSMUSG00000049799 MGI:2140219 protein coding gene leucine rich repeat containing 19
4 gene 94.665157 94.665237 positive MGI_C57BL6J_3718562 Mir872 miRBase:MI0005549,NCBI_Gene:100124456,ENSEMBL:ENSMUSG00000077921 MGI:3718562 miRNA gene microRNA 872
4 gene 94.721603 94.732564 positive MGI_C57BL6J_5623090 Gm40205 NCBI_Gene:105244622 MGI:5623090 lncRNA gene predicted gene, 40205
4 gene 94.739289 94.874976 positive MGI_C57BL6J_98664 Tek NCBI_Gene:21687,ENSEMBL:ENSMUSG00000006386 MGI:98664 protein coding gene TEK receptor tyrosine kinase
4 gene 94.875698 94.929952 negative MGI_C57BL6J_1915003 Eqtn NCBI_Gene:67753,ENSEMBL:ENSMUSG00000028575 MGI:1915003 protein coding gene equatorin, sperm acrosome associated
4 pseudogene 94.933268 94.936292 positive MGI_C57BL6J_3650224 Gm12693 NCBI_Gene:100039252,ENSEMBL:ENSMUSG00000083179 MGI:3650224 pseudogene predicted gene 12693
4 gene 94.942037 94.979112 negative MGI_C57BL6J_2444584 Mysm1 NCBI_Gene:320713,ENSEMBL:ENSMUSG00000062627 MGI:2444584 protein coding gene myb-like, SWIRM and MPN domains 1
4 gene 94.979203 95.028544 positive MGI_C57BL6J_3651291 Gm12694 NCBI_Gene:105244623,ENSEMBL:ENSMUSG00000086251 MGI:3651291 lncRNA gene predicted gene 12694
4 gene 95.029963 95.048370 negative MGI_C57BL6J_3650667 Gm12703 ENSEMBL:ENSMUSG00000052767 MGI:3650667 lncRNA gene predicted gene 12703
4 pseudogene 95.039162 95.039625 negative MGI_C57BL6J_3650671 Gm12704 ENSEMBL:ENSMUSG00000081030 MGI:3650671 pseudogene predicted gene 12704
4 gene 95.049034 95.052222 negative MGI_C57BL6J_96646 Jun NCBI_Gene:16476,ENSEMBL:ENSMUSG00000052684 MGI:96646 protein coding gene jun proto-oncogene
4 gene 95.051534 95.169036 positive MGI_C57BL6J_2652837 Junos NCBI_Gene:230451,ENSEMBL:ENSMUSG00000087366 MGI:2652837 antisense lncRNA gene jun proto-oncogene, opposite strand
4 gene 95.062650 95.062763 positive MGI_C57BL6J_4422054 n-R5s189 ENSEMBL:ENSMUSG00000084624 MGI:4422054 rRNA gene nuclear encoded rRNA 5S 189
4 gene 95.089083 95.091419 negative MGI_C57BL6J_1922511 4930551L18Rik ENSEMBL:ENSMUSG00000085377 MGI:1922511 lncRNA gene RIKEN cDNA 4930551L18 gene
4 gene 95.151740 95.157503 positive MGI_C57BL6J_5578802 Gm28096 ENSEMBL:ENSMUSG00000100189 MGI:5578802 lncRNA gene predicted gene 28096
4 gene 95.193274 95.209727 positive MGI_C57BL6J_3652178 Gm12708 NCBI_Gene:105244624,ENSEMBL:ENSMUSG00000084918 MGI:3652178 lncRNA gene predicted gene 12708
4 gene 95.196913 95.208085 negative MGI_C57BL6J_5591399 Gm32240 NCBI_Gene:102634722 MGI:5591399 lncRNA gene predicted gene, 32240
4 pseudogene 95.254826 95.259161 positive MGI_C57BL6J_5826500 Gm46863 NCBI_Gene:108168968 MGI:5826500 pseudogene predicted gene, 46863
4 gene 95.272187 95.276864 positive MGI_C57BL6J_3782003 Gm3831 NA NA protein coding gene predicted gene 3831
4 gene 95.401978 95.402790 negative MGI_C57BL6J_5579770 Gm29064 ENSEMBL:ENSMUSG00000100129 MGI:5579770 lncRNA gene predicted gene 29064
4 gene 95.464724 95.487394 negative MGI_C57BL6J_2685676 Gm830 NCBI_Gene:329892,ENSEMBL:ENSMUSG00000084939 MGI:2685676 lncRNA gene predicted gene 830
4 gene 95.483956 95.487630 positive MGI_C57BL6J_3652172 Gm12707 NCBI_Gene:102636934,ENSEMBL:ENSMUSG00000085835 MGI:3652172 lncRNA gene predicted gene 12707
4 gene 95.524044 95.524204 positive MGI_C57BL6J_5454781 Gm25004 ENSEMBL:ENSMUSG00000065745 MGI:5454781 snRNA gene predicted gene, 25004
4 gene 95.553418 95.557366 negative MGI_C57BL6J_5623091 Gm40206 NCBI_Gene:105244625 MGI:5623091 lncRNA gene predicted gene, 40206
4 gene 95.557474 95.926939 positive MGI_C57BL6J_1922828 Fggy NCBI_Gene:75578,ENSEMBL:ENSMUSG00000028573 MGI:1922828 protein coding gene FGGY carbohydrate kinase domain containing
4 pseudogene 95.561831 95.562159 negative MGI_C57BL6J_5313098 Gm20651 ENSEMBL:ENSMUSG00000093492 MGI:5313098 pseudogene predicted gene 20651
4 gene 95.634743 95.635231 positive MGI_C57BL6J_1922327 4930509A12Rik NA NA unclassified gene RIKEN cDNA 4930509A12 gene
4 gene 95.959711 95.967655 negative MGI_C57BL6J_2441751 9530080O11Rik NCBI_Gene:319247,ENSEMBL:ENSMUSG00000044125 MGI:2441751 lncRNA gene RIKEN cDNA 9530080O11 gene
4 gene 95.967195 96.025413 positive MGI_C57BL6J_1925213 Hook1 NCBI_Gene:77963,ENSEMBL:ENSMUSG00000028572 MGI:1925213 protein coding gene hook microtubule tethering protein 1
4 gene 96.027534 96.077566 negative MGI_C57BL6J_2385197 Cyp2j13 NCBI_Gene:230459,ENSEMBL:ENSMUSG00000028571 MGI:2385197 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 13
4 gene 96.029759 96.030749 positive MGI_C57BL6J_1920262 2900072D07Rik NA NA unclassified gene RIKEN cDNA 2900072D07 gene
4 pseudogene 96.072309 96.072706 negative MGI_C57BL6J_1935167 Hspe1-ps6 NCBI_Gene:93753,ENSEMBL:ENSMUSG00000083880 MGI:1935167 pseudogene heat shock protein 1 (chaperonin 10), pseudogene 6
4 gene 96.099314 96.141272 negative MGI_C57BL6J_3717097 Cyp2j12 NCBI_Gene:242546,ENSEMBL:ENSMUSG00000081225 MGI:3717097 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 12
4 pseudogene 96.151653 96.151858 negative MGI_C57BL6J_3651269 Cyp2j7-ps3 ENSEMBL:ENSMUSG00000080884 MGI:3651269 pseudogene cytochrome P450, family 2, subfamily j, polypeptide 7, pseudogene 3
4 pseudogene 96.170207 96.170385 negative MGI_C57BL6J_3651264 Cyp2j7-ps2 ENSEMBL:ENSMUSG00000083801 MGI:3651264 pseudogene cytochrome P450, family 2, subfamily j, polypeptide 7, pseudogene 2
4 pseudogene 96.190071 96.190243 negative MGI_C57BL6J_3651268 Cyp2j7-ps1 ENSEMBL:ENSMUSG00000082681 MGI:3651268 pseudogene cytochrome P450, family 2, subfamily j, polypeptide 7, pseudogene 1
4 gene 96.195192 96.236659 negative MGI_C57BL6J_2449816 Cyp2j7 NCBI_Gene:546837,ENSEMBL:ENSMUSG00000081362 MGI:2449816 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 7
4 pseudogene 96.245560 96.274271 negative MGI_C57BL6J_3652069 Cyp2j15-ps NCBI_Gene:100125600,ENSEMBL:ENSMUSG00000084286 MGI:3652069 pseudogene cytochrome P450, family 2, subfamily j, member 15, pseudogene
4 gene 96.294508 96.348698 negative MGI_C57BL6J_2140224 Cyp2j11 NCBI_Gene:100066,ENSEMBL:ENSMUSG00000066097 MGI:2140224 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 11
4 pseudogene 96.356246 96.380216 negative MGI_C57BL6J_3651954 Cyp2j14-ps NCBI_Gene:100125599,ENSEMBL:ENSMUSG00000082119 MGI:3651954 pseudogene cytochrome P450, family 2, subfamily j, member 14, pseudogene
4 gene 96.443986 96.507943 negative MGI_C57BL6J_2449817 Cyp2j8 NCBI_Gene:665095,ENSEMBL:ENSMUSG00000082932 MGI:2449817 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 8
4 gene 96.516138 96.564305 negative MGI_C57BL6J_1270148 Cyp2j6 NCBI_Gene:13110,ENSEMBL:ENSMUSG00000052914 MGI:1270148 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 6
4 gene 96.568429 96.591719 negative MGI_C57BL6J_1921769 Cyp2j9 NCBI_Gene:74519,ENSEMBL:ENSMUSG00000015224 MGI:1921769 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 9
4 gene 96.627432 96.664171 negative MGI_C57BL6J_1270149 Cyp2j5 NCBI_Gene:13109,ENSEMBL:ENSMUSG00000052520 MGI:1270149 protein coding gene cytochrome P450, family 2, subfamily j, polypeptide 5
4 gene 96.723349 96.786830 negative MGI_C57BL6J_3650206 Gm12695 NCBI_Gene:620779,ENSEMBL:ENSMUSG00000078639 MGI:3650206 protein coding gene predicted gene 12695
4 gene 96.787317 96.794899 positive MGI_C57BL6J_5593212 Gm34053 NCBI_Gene:102637171 MGI:5593212 lncRNA gene predicted gene, 34053
4 gene 96.916945 96.917007 positive MGI_C57BL6J_5530961 Gm27579 ENSEMBL:ENSMUSG00000088738 MGI:5530961 snRNA gene predicted gene, 27579
4 gene 96.917020 96.917083 positive MGI_C57BL6J_5530903 Gm27521 ENSEMBL:ENSMUSG00000098261 MGI:5530903 snRNA gene predicted gene, 27521
4 gene 97.181077 97.183167 negative MGI_C57BL6J_3642867 Gm10192 NA NA protein coding gene predicted gene 10192
4 gene 97.415417 97.416629 negative MGI_C57BL6J_5623092 Gm40207 NCBI_Gene:105244626 MGI:5623092 lncRNA gene predicted gene, 40207
4 pseudogene 97.521274 97.522548 negative MGI_C57BL6J_3649288 Gm12696 NCBI_Gene:620883,ENSEMBL:ENSMUSG00000084159 MGI:3649288 pseudogene predicted gene 12696
4 pseudogene 97.556404 97.557064 positive MGI_C57BL6J_3643458 Gm7248 NCBI_Gene:638698 MGI:3643458 pseudogene predicted gene 7248
4 pseudogene 97.556404 97.557070 negative MGI_C57BL6J_3651292 Gm12697 ENSEMBL:ENSMUSG00000082683 MGI:3651292 pseudogene predicted gene 12697
4 gene 97.567875 97.778078 negative MGI_C57BL6J_2442873 E130114P18Rik NCBI_Gene:319865,ENSEMBL:ENSMUSG00000048747 MGI:2442873 protein coding gene RIKEN cDNA E130114P18 gene
4 gene 97.581716 98.118876 positive MGI_C57BL6J_108056 Nfia NCBI_Gene:18027,ENSEMBL:ENSMUSG00000028565 MGI:108056 protein coding gene nuclear factor I/A
4 gene 97.582333 97.584624 negative MGI_C57BL6J_2444134 D130039L10Rik NA NA unclassified non-coding RNA gene RIKEN cDNA D130039L10 gene
4 gene 97.747097 97.761008 negative MGI_C57BL6J_3651064 Gm12676 NCBI_Gene:102637577,ENSEMBL:ENSMUSG00000085710 MGI:3651064 lncRNA gene predicted gene 12676
4 gene 97.773693 97.777427 negative MGI_C57BL6J_5621594 Gm38709 NCBI_Gene:105242444 MGI:5621594 lncRNA gene predicted gene, 38709
4 gene 97.774523 97.776443 negative MGI_C57BL6J_2443783 A130013F12Rik NA NA unclassified gene RIKEN cDNA A130013F12 gene
4 gene 97.862410 97.869231 negative MGI_C57BL6J_5011602 Gm19417 NCBI_Gene:102637515 MGI:5011602 lncRNA gene predicted gene, 19417
4 gene 97.867258 97.870082 positive MGI_C57BL6J_1914791 4932416J16Rik NA NA unclassified gene RIKEN cDNA 4932416J16 gene
4 gene 97.930425 97.940987 positive MGI_C57BL6J_5623093 Gm40208 NCBI_Gene:105244627 MGI:5623093 lncRNA gene predicted gene, 40208
4 gene 98.018556 98.024773 negative MGI_C57BL6J_5593377 Gm34218 NCBI_Gene:102637398 MGI:5593377 lncRNA gene predicted gene, 34218
4 gene 98.125654 98.131273 positive MGI_C57BL6J_5593943 Gm34784 NCBI_Gene:102638152 MGI:5593943 lncRNA gene predicted gene, 34784
4 pseudogene 98.145273 98.244464 negative MGI_C57BL6J_3650220 Gm12691 NCBI_Gene:100039459,ENSEMBL:ENSMUSG00000081096 MGI:3650220 pseudogene predicted gene 12691
4 pseudogene 98.234745 98.235290 negative MGI_C57BL6J_3651859 Gm12692 NCBI_Gene:384106,ENSEMBL:ENSMUSG00000082388 MGI:3651859 pseudogene predicted gene 12692
4 pseudogene 98.268083 98.271286 negative MGI_C57BL6J_3650112 Gm12787 NCBI_Gene:100502616,ENSEMBL:ENSMUSG00000083644 MGI:3650112 pseudogene predicted gene 12787
4 gene 98.275725 98.275838 positive MGI_C57BL6J_5453980 Gm24203 ENSEMBL:ENSMUSG00000064883 MGI:5453980 unclassified non-coding RNA gene predicted gene, 24203
4 gene 98.321341 98.331960 positive MGI_C57BL6J_1915618 0610025J13Rik NCBI_Gene:78687,ENSEMBL:ENSMUSG00000046683 MGI:1915618 lncRNA gene RIKEN cDNA 0610025J13 gene
4 pseudogene 98.352427 98.352734 positive MGI_C57BL6J_3649859 Gm12788 ENSEMBL:ENSMUSG00000082144 MGI:3649859 pseudogene predicted gene 12788
4 gene 98.355370 98.383306 negative MGI_C57BL6J_2137022 Tm2d1 NCBI_Gene:94043,ENSEMBL:ENSMUSG00000028563 MGI:2137022 protein coding gene TM2 domain containing 1
4 gene 98.383402 98.383491 negative MGI_C57BL6J_5454737 Gm24960 ENSEMBL:ENSMUSG00000088548 MGI:5454737 snRNA gene predicted gene, 24960
4 gene 98.395622 98.719603 positive MGI_C57BL6J_1277960 Patj NCBI_Gene:12695,ENSEMBL:ENSMUSG00000061859 MGI:1277960 protein coding gene PATJ, crumbs cell polarity complex component
4 gene 98.557740 98.557865 negative MGI_C57BL6J_5452402 Gm22625 ENSEMBL:ENSMUSG00000094456 MGI:5452402 miRNA gene predicted gene, 22625
4 gene 98.579527 98.588009 positive MGI_C57BL6J_5623095 Gm40210 NCBI_Gene:105244629 MGI:5623095 lncRNA gene predicted gene, 40210
4 gene 98.661637 98.661732 positive MGI_C57BL6J_5455931 Gm26154 ENSEMBL:ENSMUSG00000076294 MGI:5455931 miRNA gene predicted gene, 26154
4 pseudogene 98.664366 98.666137 positive MGI_C57BL6J_3651461 Gm12846 NCBI_Gene:100417687,ENSEMBL:ENSMUSG00000081046 MGI:3651461 pseudogene predicted gene 12846
4 gene 98.696893 98.699781 negative MGI_C57BL6J_5594296 Gm35137 NCBI_Gene:102638614 MGI:5594296 lncRNA gene predicted gene, 35137
4 gene 98.700445 98.700755 negative MGI_C57BL6J_5594232 Gm35073 NCBI_Gene:102638531 MGI:5594232 lncRNA gene predicted gene, 35073
4 gene 98.726734 98.738486 positive MGI_C57BL6J_3578435 L1td1 NCBI_Gene:381591,ENSEMBL:ENSMUSG00000087166 MGI:3578435 protein coding gene LINE-1 type transposase domain containing 1
4 pseudogene 98.745735 98.745822 positive MGI_C57BL6J_4937010 Gm17376 ENSEMBL:ENSMUSG00000090718 MGI:4937010 pseudogene predicted gene, 17376
4 gene 98.754892 98.817801 negative MGI_C57BL6J_3043381 Kank4 NCBI_Gene:242553,ENSEMBL:ENSMUSG00000035407 MGI:3043381 protein coding gene KN motif and ankyrin repeat domains 4
4 gene 98.793768 98.799037 positive MGI_C57BL6J_3026921 Kank4os NCBI_Gene:399570,ENSEMBL:ENSMUSG00000085843 MGI:3026921 antisense lncRNA gene KN motif and ankyrin repeat domains 4, opposite strand
4 gene 98.818475 98.823840 negative MGI_C57BL6J_3588230 I0C0044D17Rik NCBI_Gene:545660,ENSEMBL:ENSMUSG00000073794 MGI:3588230 protein coding gene RIKEN cDNA I0C0044D17 gene
4 pseudogene 98.852744 98.856063 positive MGI_C57BL6J_3649254 Gm12851 NCBI_Gene:102639194,ENSEMBL:ENSMUSG00000084188 MGI:3649254 pseudogene predicted gene 12851
4 gene 98.923623 98.935543 positive MGI_C57BL6J_2385198 Usp1 NCBI_Gene:230484,ENSEMBL:ENSMUSG00000028560 MGI:2385198 protein coding gene ubiquitin specific peptidase 1
4 gene 98.936659 99.121787 negative MGI_C57BL6J_1914549 Dock7 NCBI_Gene:67299,ENSEMBL:ENSMUSG00000028556 MGI:1914549 protein coding gene dedicator of cytokinesis 7
4 gene 99.030954 99.046111 positive MGI_C57BL6J_1353627 Angptl3 NCBI_Gene:30924,ENSEMBL:ENSMUSG00000028553 MGI:1353627 protein coding gene angiopoietin-like 3
4 pseudogene 99.102950 99.103833 negative MGI_C57BL6J_3651942 Gm12852 NCBI_Gene:100417329,ENSEMBL:ENSMUSG00000081733 MGI:3651942 pseudogene predicted gene 12852
4 gene 99.116414 99.118301 positive MGI_C57BL6J_3650670 Gm12705 ENSEMBL:ENSMUSG00000087395 MGI:3650670 lncRNA gene predicted gene 12705
4 gene 99.146914 99.161642 negative MGI_C57BL6J_3650649 Gm12681 ENSEMBL:ENSMUSG00000086498 MGI:3650649 lncRNA gene predicted gene 12681
4 gene 99.189158 99.297258 positive MGI_C57BL6J_2651854 Atg4c NCBI_Gene:242557,ENSEMBL:ENSMUSG00000028550 MGI:2651854 protein coding gene autophagy related 4C, cysteine peptidase
4 gene 99.272671 99.275145 positive MGI_C57BL6J_3642542 Gm10305 ENSEMBL:ENSMUSG00000104479 MGI:3642542 unclassified gene predicted gene 10305
4 gene 99.295900 99.297258 positive MGI_C57BL6J_3650433 Gm12689 ENSEMBL:ENSMUSG00000070891 MGI:3650433 protein coding gene predicted gene 12689
4 gene 99.314629 99.332908 positive MGI_C57BL6J_5594538 Gm35379 NCBI_Gene:102638939 MGI:5594538 lncRNA gene predicted gene, 35379
4 gene 99.342178 99.342812 negative MGI_C57BL6J_5594696 Gm35537 NCBI_Gene:102639160 MGI:5594696 lncRNA gene predicted gene, 35537
4 gene 99.376066 99.385712 negative MGI_C57BL6J_5610784 Gm37556 ENSEMBL:ENSMUSG00000103097 MGI:5610784 unclassified gene predicted gene, 37556
4 pseudogene 99.418498 99.418711 negative MGI_C57BL6J_3650437 Gm12685 ENSEMBL:ENSMUSG00000081184 MGI:3650437 pseudogene predicted gene 12685
4 pseudogene 99.418773 99.419169 positive MGI_C57BL6J_3652197 Gm12686 ENSEMBL:ENSMUSG00000082442 MGI:3652197 pseudogene predicted gene 12686
4 pseudogene 99.430059 99.431274 negative MGI_C57BL6J_3650091 Gm12684 NCBI_Gene:665212,ENSEMBL:ENSMUSG00000081150 MGI:3650091 pseudogene predicted gene 12684
4 pseudogene 99.520052 99.520466 negative MGI_C57BL6J_3650644 Gm12683 ENSEMBL:ENSMUSG00000080803 MGI:3650644 pseudogene predicted gene 12683
4 gene 99.525932 99.530662 positive MGI_C57BL6J_5610345 Gm37117 ENSEMBL:ENSMUSG00000103575 MGI:5610345 unclassified gene predicted gene, 37117
4 gene 99.554786 99.569348 negative MGI_C57BL6J_5623096 Gm40211 NCBI_Gene:105244631 MGI:5623096 lncRNA gene predicted gene, 40211
4 gene 99.569500 99.573011 positive MGI_C57BL6J_3650444 Gm12690 ENSEMBL:ENSMUSG00000087332 MGI:3650444 lncRNA gene predicted gene 12690
4 pseudogene 99.615799 99.616561 negative MGI_C57BL6J_3650435 Gm12687 NCBI_Gene:100417847,ENSEMBL:ENSMUSG00000083698 MGI:3650435 pseudogene predicted gene 12687
4 gene 99.653607 99.654983 negative MGI_C57BL6J_3650434 Gm12688 ENSEMBL:ENSMUSG00000086096 MGI:3650434 lncRNA gene predicted gene 12688
4 gene 99.655718 99.656013 negative MGI_C57BL6J_1920013 2810439L12Rik NA NA unclassified gene RIKEN cDNA 2810439L12 gene
4 gene 99.656299 99.658671 positive MGI_C57BL6J_1347473 Foxd3 NCBI_Gene:15221,ENSEMBL:ENSMUSG00000067261 MGI:1347473 protein coding gene forkhead box D3
4 gene 99.657742 99.657830 positive MGI_C57BL6J_5453143 Gm23366 ENSEMBL:ENSMUSG00000092763 MGI:5453143 miRNA gene predicted gene, 23366
4 gene 99.662541 99.712972 negative MGI_C57BL6J_3650643 Gm12682 ENSEMBL:ENSMUSG00000086592 MGI:3650643 lncRNA gene predicted gene 12682
4 gene 99.715599 99.763460 positive MGI_C57BL6J_2444031 Alg6 NCBI_Gene:320438,ENSEMBL:ENSMUSG00000073792 MGI:2444031 protein coding gene asparagine-linked glycosylation 6 (alpha-1,3,-glucosyltransferase)
4 gene 99.765402 99.929813 negative MGI_C57BL6J_1914983 Itgb3bp NCBI_Gene:67733,ENSEMBL:ENSMUSG00000028549 MGI:1914983 protein coding gene integrin beta 3 binding protein (beta3-endonexin)
4 gene 99.829198 99.912788 positive MGI_C57BL6J_2385199 Efcab7 NCBI_Gene:230500,ENSEMBL:ENSMUSG00000073791 MGI:2385199 protein coding gene EF-hand calcium binding domain 7
4 gene 99.909797 99.909878 positive MGI_C57BL6J_5456202 Gm26425 ENSEMBL:ENSMUSG00000084478 MGI:5456202 snRNA gene predicted gene, 26425
4 gene 99.929414 99.987294 positive MGI_C57BL6J_97565 Pgm1 NCBI_Gene:72157,ENSEMBL:ENSMUSG00000025791 MGI:97565 protein coding gene phosphoglucomutase 1
4 gene 99.929818 99.932327 positive MGI_C57BL6J_3040690 BC062258 NCBI_Gene:102643247 MGI:3040690 lncRNA gene cDNA sequence BC062258
4 gene 100.052520 100.065984 positive MGI_C57BL6J_3650874 Gm12702 ENSEMBL:ENSMUSG00000085142 MGI:3650874 lncRNA gene predicted gene 12702
4 gene 100.092757 100.095643 negative MGI_C57BL6J_5594860 Gm35701 NCBI_Gene:102639371 MGI:5594860 lncRNA gene predicted gene, 35701
4 gene 100.095791 100.444806 positive MGI_C57BL6J_1347520 Ror1 NCBI_Gene:26563,ENSEMBL:ENSMUSG00000035305 MGI:1347520 protein coding gene receptor tyrosine kinase-like orphan receptor 1
4 gene 100.119621 100.122782 positive MGI_C57BL6J_3650875 Gm12701 NCBI_Gene:105244634,ENSEMBL:ENSMUSG00000086385 MGI:3650875 lncRNA gene predicted gene 12701
4 pseudogene 100.361362 100.362059 negative MGI_C57BL6J_3650672 Gm12706 ENSEMBL:ENSMUSG00000080967 MGI:3650672 pseudogene predicted gene 12706
4 gene 100.376583 100.393210 negative MGI_C57BL6J_5594919 Gm35760 NCBI_Gene:102639448 MGI:5594919 lncRNA gene predicted gene, 35760
4 pseudogene 100.465875 100.467142 positive MGI_C57BL6J_5010473 Gm18288 NCBI_Gene:100416841 MGI:5010473 pseudogene predicted gene, 18288
4 gene 100.478849 100.550147 positive MGI_C57BL6J_3588216 Ube2u NCBI_Gene:381534,ENSEMBL:ENSMUSG00000069733 MGI:3588216 protein coding gene ubiquitin-conjugating enzyme E2U (putative)
4 gene 100.523226 100.528028 negative MGI_C57BL6J_3651101 Ube2uos NCBI_Gene:105244635,ENSEMBL:ENSMUSG00000085871 MGI:3651101 antisense lncRNA gene ubiquitin-conjugating enzyme E2U (putative), opposite strand
4 pseudogene 100.566571 100.568155 negative MGI_C57BL6J_3651098 Ccdc50-ps NCBI_Gene:277707,ENSEMBL:ENSMUSG00000081553 MGI:3651098 pseudogene Ccdc50 retrotransposed pseudogene
4 pseudogene 100.579351 100.581734 positive MGI_C57BL6J_3651090 Gm12700 NCBI_Gene:621573,ENSEMBL:ENSMUSG00000082601 MGI:3651090 pseudogene predicted gene 12700
4 gene 100.687671 100.689010 negative MGI_C57BL6J_5826525 Gm46888 NCBI_Gene:108169003 MGI:5826525 lncRNA gene predicted gene, 46888
4 gene 100.776675 101.029220 positive MGI_C57BL6J_2444177 Cachd1 NCBI_Gene:320508,ENSEMBL:ENSMUSG00000028532 MGI:2444177 protein coding gene cache domain containing 1
4 gene 101.019151 101.020697 negative MGI_C57BL6J_3642534 Gm10577 ENSEMBL:ENSMUSG00000073789 MGI:3642534 protein coding gene predicted gene 10577
4 gene 101.054439 101.055263 negative MGI_C57BL6J_3642535 Gm10576 ENSEMBL:ENSMUSG00000102578 MGI:3642535 protein coding gene predicted gene 10576
4 gene 101.068983 101.152370 positive MGI_C57BL6J_2443623 Raver2 NCBI_Gene:242570,ENSEMBL:ENSMUSG00000035275 MGI:2443623 protein coding gene ribonucleoprotein, PTB-binding 2
4 gene 101.074025 101.076703 positive MGI_C57BL6J_5595115 Gm35956 NCBI_Gene:102639705 MGI:5595115 lncRNA gene predicted gene, 35956
4 gene 101.103588 101.103650 negative MGI_C57BL6J_5451877 Gm22100 ENSEMBL:ENSMUSG00000088551 MGI:5451877 snRNA gene predicted gene, 22100
4 gene 101.151974 101.265291 negative MGI_C57BL6J_96628 Jak1 NCBI_Gene:16451,ENSEMBL:ENSMUSG00000028530 MGI:96628 protein coding gene Janus kinase 1
4 gene 101.186764 101.186867 positive MGI_C57BL6J_5454245 Gm24468 ENSEMBL:ENSMUSG00000077677 MGI:5454245 snRNA gene predicted gene, 24468
4 pseudogene 101.210416 101.210587 negative MGI_C57BL6J_3650357 Gm12785 ENSEMBL:ENSMUSG00000082928 MGI:3650357 pseudogene predicted gene 12785
4 pseudogene 101.219763 101.220279 positive MGI_C57BL6J_5011248 Gm19063 NCBI_Gene:100418189 MGI:5011248 pseudogene predicted gene, 19063
4 gene 101.271143 101.271306 positive MGI_C57BL6J_5454901 Gm25124 ENSEMBL:ENSMUSG00000065279 MGI:5454901 snRNA gene predicted gene, 25124
4 gene 101.284221 101.285203 positive MGI_C57BL6J_3652119 Gm12801 ENSEMBL:ENSMUSG00000085863 MGI:3652119 lncRNA gene predicted gene 12801
4 gene 101.292414 101.321745 negative MGI_C57BL6J_3649207 Gm12796 ENSEMBL:ENSMUSG00000085721 MGI:3649207 lncRNA gene predicted gene 12796
4 pseudogene 101.341357 101.341648 positive MGI_C57BL6J_3649401 Gm12793 ENSEMBL:ENSMUSG00000081621 MGI:3649401 pseudogene predicted gene 12793
4 gene 101.346524 101.356735 negative MGI_C57BL6J_1925116 E130102H24Rik NCBI_Gene:77866,ENSEMBL:ENSMUSG00000086782 MGI:1925116 lncRNA gene RIKEN cDNA E130102H24 gene
4 gene 101.346945 101.347027 negative MGI_C57BL6J_2676803 Mir101a miRBase:MI0000148,NCBI_Gene:387143,ENSEMBL:ENSMUSG00000065451 MGI:2676803 miRNA gene microRNA 101a
4 gene 101.353783 101.399185 positive MGI_C57BL6J_1915650 0610043K17Rik NCBI_Gene:68400,ENSEMBL:ENSMUSG00000087361 MGI:1915650 lncRNA gene RIKEN cDNA 0610043K17 gene
4 pseudogene 101.362177 101.362890 negative MGI_C57BL6J_3649205 Gm12795 NCBI_Gene:100416255,ENSEMBL:ENSMUSG00000083614 MGI:3649205 pseudogene predicted gene 12795
4 gene 101.403081 101.407856 positive MGI_C57BL6J_3651483 Gm12798 ENSEMBL:ENSMUSG00000084758 MGI:3651483 lncRNA gene predicted gene 12798
4 gene 101.418847 101.467771 positive MGI_C57BL6J_87979 Ak4 NCBI_Gene:11639,ENSEMBL:ENSMUSG00000028527 MGI:87979 protein coding gene adenylate kinase 4
4 gene 101.496022 101.642799 positive MGI_C57BL6J_1919935 Dnajc6 NCBI_Gene:72685,ENSEMBL:ENSMUSG00000028528 MGI:1919935 protein coding gene DnaJ heat shock protein family (Hsp40) member C6
4 gene 101.543298 101.556812 negative MGI_C57BL6J_5595171 Gm36012 NCBI_Gene:102639781 MGI:5595171 lncRNA gene predicted gene, 36012
4 gene 101.555095 101.555368 positive MGI_C57BL6J_5452310 Gm22533 ENSEMBL:ENSMUSG00000089446 MGI:5452310 unclassified non-coding RNA gene predicted gene, 22533
4 gene 101.647718 101.659364 positive MGI_C57BL6J_2687005 Leprot NCBI_Gene:230514,ENSEMBL:ENSMUSG00000035212 MGI:2687005 protein coding gene leptin receptor overlapping transcript
4 gene 101.717134 101.815354 positive MGI_C57BL6J_104993 Lepr NCBI_Gene:16847,ENSEMBL:ENSMUSG00000057722 MGI:104993 protein coding gene leptin receptor
4 gene 101.834969 101.844023 negative MGI_C57BL6J_3588238 B020004J07Rik NCBI_Gene:545662,ENSEMBL:ENSMUSG00000035201 MGI:3588238 protein coding gene RIKEN cDNA B020004J07 gene
4 pseudogene 101.875318 101.876112 positive MGI_C57BL6J_3649397 Gm12791 NCBI_Gene:665362,ENSEMBL:ENSMUSG00000081121 MGI:3649397 pseudogene predicted gene 12791
4 pseudogene 101.884040 101.884312 positive MGI_C57BL6J_3649203 Gm12797 ENSEMBL:ENSMUSG00000081045 MGI:3649203 pseudogene predicted gene 12797
4 gene 101.890020 101.893789 negative MGI_C57BL6J_3045359 C130073F10Rik NCBI_Gene:242574,ENSEMBL:ENSMUSG00000046133 MGI:3045359 protein coding gene RIKEN cDNA C130073F10 gene
4 pseudogene 101.895964 101.896982 negative MGI_C57BL6J_3649402 Gm12792 NCBI_Gene:384033,ENSEMBL:ENSMUSG00000084208 MGI:3649402 pseudogene predicted gene 12792
4 gene 101.909121 101.911908 positive MGI_C57BL6J_3652120 Gm12800 NCBI_Gene:381535,ENSEMBL:ENSMUSG00000037028 MGI:3652120 protein coding gene predicted gene 12800
4 gene 101.940407 101.943183 positive MGI_C57BL6J_3795847 Gm12794 NCBI_Gene:332923,ENSEMBL:ENSMUSG00000070890 MGI:3795847 protein coding gene predicted gene 12794
4 gene 101.967453 101.981049 negative MGI_C57BL6J_3649398 Gm12790 ENSEMBL:ENSMUSG00000078626 MGI:3649398 protein coding gene predicted gene 12790
4 gene 101.986626 101.990231 positive MGI_C57BL6J_3649399 Gm12789 NCBI_Gene:381536,ENSEMBL:ENSMUSG00000078625 MGI:3649399 protein coding gene predicted gene 12789
4 pseudogene 102.046379 102.049786 negative MGI_C57BL6J_3652118 Gm12799 NCBI_Gene:433739,ENSEMBL:ENSMUSG00000082264 MGI:3652118 pseudogene predicted gene 12799
4 gene 102.087528 102.607262 positive MGI_C57BL6J_99557 Pde4b NCBI_Gene:18578,ENSEMBL:ENSMUSG00000028525 MGI:99557 protein coding gene phosphodiesterase 4B, cAMP specific
4 pseudogene 102.327355 102.328016 positive MGI_C57BL6J_5010404 Gm18219 NCBI_Gene:100416738 MGI:5010404 pseudogene predicted gene, 18219
4 pseudogene 102.333046 102.333717 positive MGI_C57BL6J_5010405 Gm18220 NCBI_Gene:100416739 MGI:5010405 pseudogene predicted gene, 18220
4 gene 102.736812 102.736939 positive MGI_C57BL6J_5454646 Gm24869 ENSEMBL:ENSMUSG00000077260 MGI:5454646 snoRNA gene predicted gene, 24869
4 gene 102.741297 102.977426 positive MGI_C57BL6J_1920344 Sgip1 NCBI_Gene:73094,ENSEMBL:ENSMUSG00000028524 MGI:1920344 protein coding gene SH3-domain GRB2-like (endophilin) interacting protein 1
4 gene 102.967266 102.989755 negative MGI_C57BL6J_3651946 Gm12709 NCBI_Gene:100504717,ENSEMBL:ENSMUSG00000085181 MGI:3651946 lncRNA gene predicted gene 12709
4 gene 102.978388 103.005594 positive MGI_C57BL6J_1914594 Tctex1d1 NCBI_Gene:67344,ENSEMBL:ENSMUSG00000028523 MGI:1914594 protein coding gene Tctex1 domain containing 1
4 gene 103.004106 103.011965 negative MGI_C57BL6J_2140631 BB031773 NCBI_Gene:100473,ENSEMBL:ENSMUSG00000085041 MGI:2140631 lncRNA gene expressed sequence BB031773
4 gene 103.017872 103.026842 negative MGI_C57BL6J_1346085 Insl5 NCBI_Gene:23919,ENSEMBL:ENSMUSG00000066090 MGI:1346085 protein coding gene insulin-like 5
4 gene 103.034755 103.114555 negative MGI_C57BL6J_2385328 Wdr78 NCBI_Gene:242584,ENSEMBL:ENSMUSG00000035126 MGI:2385328 protein coding gene WD repeat domain 78
4 pseudogene 103.103527 103.103742 positive MGI_C57BL6J_3651493 Gm12710 ENSEMBL:ENSMUSG00000080744 MGI:3651493 pseudogene predicted gene 12710
4 gene 103.111443 103.114614 negative MGI_C57BL6J_2443919 E030030F06Rik NA NA protein coding gene RIKEN cDNA E030030F06 gene
4 gene 103.114390 103.165754 positive MGI_C57BL6J_1918398 Mier1 NCBI_Gene:71148,ENSEMBL:ENSMUSG00000028522 MGI:1918398 protein coding gene MEIR1 treanscription regulator
4 gene 103.170649 103.215368 negative MGI_C57BL6J_2140361 Slc35d1 NCBI_Gene:242585,ENSEMBL:ENSMUSG00000028521 MGI:2140361 protein coding gene solute carrier family 35 (UDP-glucuronic acid/UDP-N-acetylgalactosamine dual transporter), member D1
4 gene 103.214943 103.223117 positive MGI_C57BL6J_5826501 Gm46864 NCBI_Gene:108168969 MGI:5826501 lncRNA gene predicted gene, 46864
4 gene 103.217702 103.219592 positive MGI_C57BL6J_5690429 Gm44037 ENSEMBL:ENSMUSG00000107726 MGI:5690429 lncRNA gene predicted gene, 44037
4 gene 103.230445 103.290953 negative MGI_C57BL6J_1918191 4921539E11Rik NCBI_Gene:70941,ENSEMBL:ENSMUSG00000028520 MGI:1918191 protein coding gene RIKEN cDNA 4921539E11 gene
4 gene 103.290959 103.311832 positive MGI_C57BL6J_1918900 4930456L15Rik NCBI_Gene:71650,ENSEMBL:ENSMUSG00000078618 MGI:1918900 lncRNA gene RIKEN cDNA 4930456L15 gene
4 gene 103.302836 103.313555 negative MGI_C57BL6J_5595682 Gm36523 NCBI_Gene:102640470 MGI:5595682 lncRNA gene predicted gene, 36523
4 gene 103.313209 103.371869 positive MGI_C57BL6J_1914263 Oma1 NCBI_Gene:67013,ENSEMBL:ENSMUSG00000035069 MGI:1914263 protein coding gene OMA1 zinc metallopeptidase
4 gene 103.381300 103.382463 positive MGI_C57BL6J_1918233 4931409D07Rik NA NA unclassified gene RIKEN cDNA 4931409D07 gene
4 gene 103.382500 103.492188 positive MGI_C57BL6J_3651516 Gm12718 NCBI_Gene:622167,ENSEMBL:ENSMUSG00000086136 MGI:3651516 lncRNA gene predicted gene 12718
4 gene 103.471859 103.471959 positive MGI_C57BL6J_5452841 Gm23064 ENSEMBL:ENSMUSG00000094477 MGI:5452841 miRNA gene predicted gene, 23064
4 gene 103.538845 103.550682 negative MGI_C57BL6J_3651748 Gm12720 ENSEMBL:ENSMUSG00000087482 MGI:3651748 lncRNA gene predicted gene 12720
4 pseudogene 103.543176 103.544763 negative MGI_C57BL6J_3650738 Gm12716 NCBI_Gene:665451,ENSEMBL:ENSMUSG00000081584 MGI:3650738 pseudogene predicted gene 12716
4 pseudogene 103.563325 103.565229 positive MGI_C57BL6J_3650759 Gm12715 NCBI_Gene:100039940,ENSEMBL:ENSMUSG00000059195 MGI:3650759 pseudogene predicted gene 12715
4 gene 103.564203 103.564286 positive MGI_C57BL6J_5452578 Gm22801 ENSEMBL:ENSMUSG00000093365 MGI:5452578 miRNA gene predicted gene, 22801
4 gene 103.586272 103.586400 negative MGI_C57BL6J_5455654 Gm25877 ENSEMBL:ENSMUSG00000077514 MGI:5455654 snoRNA gene predicted gene, 25877
4 gene 103.610421 103.619145 negative MGI_C57BL6J_5595763 Gm36604 NCBI_Gene:102640570 MGI:5595763 lncRNA gene predicted gene, 36604
4 gene 103.619359 104.744844 positive MGI_C57BL6J_108554 Dab1 NCBI_Gene:13131,ENSEMBL:ENSMUSG00000028519 MGI:108554 protein coding gene disabled 1
4 gene 103.711659 103.712899 positive MGI_C57BL6J_1920104 2900034C19Rik NA NA unclassified gene RIKEN cDNA 2900034C19 gene
4 pseudogene 103.939301 103.939541 negative MGI_C57BL6J_3651747 Gm12719 ENSEMBL:ENSMUSG00000080913 MGI:3651747 pseudogene predicted gene 12719
4 pseudogene 103.940959 103.942120 positive MGI_C57BL6J_3650774 Gm12717 NCBI_Gene:622315,ENSEMBL:ENSMUSG00000081696 MGI:3650774 pseudogene predicted gene 12717
4 gene 103.990972 104.028719 negative MGI_C57BL6J_5595820 Gm36661 NCBI_Gene:102640646 MGI:5595820 lncRNA gene predicted gene, 36661
4 gene 104.328252 104.330557 positive MGI_C57BL6J_3642623 Gm10304 NA NA unclassified gene predicted gene 10304
4 gene 104.528401 104.532253 positive MGI_C57BL6J_3641719 AY512949 NA NA unclassified gene cDNA sequence AY512949
4 gene 104.766317 104.804548 positive MGI_C57BL6J_88236 C8b NCBI_Gene:110382,ENSEMBL:ENSMUSG00000029656 MGI:88236 protein coding gene complement component 8, beta polypeptide
4 gene 104.815679 104.876487 negative MGI_C57BL6J_2668347 C8a NCBI_Gene:230558,ENSEMBL:ENSMUSG00000035031 MGI:2668347 protein coding gene complement component 8, alpha polypeptide
4 gene 104.833832 105.016864 positive MGI_C57BL6J_2685466 Fyb2 NCBI_Gene:242594,ENSEMBL:ENSMUSG00000078612 MGI:2685466 protein coding gene FYN binding protein 2
4 gene 104.857329 104.859137 positive MGI_C57BL6J_4937296 Gm17662 ENSEMBL:ENSMUSG00000095386 MGI:4937296 protein coding gene predicted gene, 17662
4 gene 104.887207 104.890083 negative MGI_C57BL6J_5623101 Gm40216 NCBI_Gene:105244639 MGI:5623101 lncRNA gene predicted gene, 40216
4 pseudogene 104.969435 104.970924 negative MGI_C57BL6J_3650292 Gm12721 NCBI_Gene:108168943,ENSEMBL:ENSMUSG00000083791 MGI:3650292 pseudogene predicted gene 12721
4 gene 104.971196 104.972639 negative MGI_C57BL6J_5595994 Gm36835 NCBI_Gene:102640873 MGI:5595994 lncRNA gene predicted gene, 36835
4 gene 105.029162 105.109898 negative MGI_C57BL6J_1336173 Prkaa2 NCBI_Gene:108079,ENSEMBL:ENSMUSG00000028518 MGI:1336173 protein coding gene protein kinase, AMP-activated, alpha 2 catalytic subunit
4 gene 105.109982 105.112322 positive MGI_C57BL6J_5596052 Gm36893 NCBI_Gene:102640948 MGI:5596052 lncRNA gene predicted gene, 36893
4 gene 105.153123 105.156032 negative MGI_C57BL6J_5588997 Gm29838 NCBI_Gene:102631520 MGI:5588997 lncRNA gene predicted gene, 29838
4 gene 105.157347 105.232767 positive MGI_C57BL6J_1915166 Plpp3 NCBI_Gene:67916,ENSEMBL:ENSMUSG00000028517 MGI:1915166 protein coding gene phospholipid phosphatase 3
4 gene 105.200736 105.201913 positive MGI_C57BL6J_1924365 6030451C04Rik NA NA unclassified gene RIKEN cDNA 6030451C04 gene
4 gene 105.310378 105.319147 negative MGI_C57BL6J_5623102 Gm40217 NCBI_Gene:105244640 MGI:5623102 lncRNA gene predicted gene, 40217
4 pseudogene 105.374392 105.374951 negative MGI_C57BL6J_3652209 Gm12722 NCBI_Gene:433742,ENSEMBL:ENSMUSG00000081819 MGI:3652209 pseudogene predicted gene 12722
4 pseudogene 105.511232 105.511682 positive MGI_C57BL6J_3652213 Gm12723 ENSEMBL:ENSMUSG00000083128 MGI:3652213 pseudogene predicted gene 12723
4 pseudogene 105.578311 105.578993 positive MGI_C57BL6J_3649291 Gm12726 NCBI_Gene:108169004,ENSEMBL:ENSMUSG00000082061 MGI:3649291 pseudogene predicted gene 12726
4 gene 105.789869 105.794909 positive MGI_C57BL6J_3649486 Gm12728 NCBI_Gene:269569,ENSEMBL:ENSMUSG00000083780 MGI:3649486 protein coding gene predicted gene 12728
4 gene 105.841215 105.845708 negative MGI_C57BL6J_5589081 Gm29922 NCBI_Gene:102631627 MGI:5589081 lncRNA gene predicted gene, 29922
4 gene 105.975575 105.975885 negative MGI_C57BL6J_5454140 Gm24363 ENSEMBL:ENSMUSG00000089065 MGI:5454140 unclassified non-coding RNA gene predicted gene, 24363
4 gene 106.037315 106.048796 negative MGI_C57BL6J_5589425 Gm30266 NCBI_Gene:102632106 MGI:5589425 lncRNA gene predicted gene, 30266
4 gene 106.053995 106.057803 negative MGI_C57BL6J_5589358 Gm30199 NCBI_Gene:102632021 MGI:5589358 lncRNA gene predicted gene, 30199
4 gene 106.088714 106.105068 negative MGI_C57BL6J_3649488 Gm12729 ENSEMBL:ENSMUSG00000085790 MGI:3649488 lncRNA gene predicted gene 12729
4 pseudogene 106.098835 106.099533 positive MGI_C57BL6J_3649747 Gm12727 NCBI_Gene:384038,ENSEMBL:ENSMUSG00000082768 MGI:3649747 pseudogene predicted gene 12727
4 gene 106.118968 106.119082 negative MGI_C57BL6J_5455824 Gm26047 ENSEMBL:ENSMUSG00000106163,ENSEMBL:ENSMUSG00000087933 MGI:5455824 snoRNA gene predicted gene, 26047
4 gene 106.124248 106.127182 positive MGI_C57BL6J_5589285 Gm30126 NCBI_Gene:102631914 MGI:5589285 lncRNA gene predicted gene, 30126
4 gene 106.126251 106.145839 negative MGI_C57BL6J_5589206 Gm30047 NCBI_Gene:102631801 MGI:5589206 lncRNA gene predicted gene, 30047
4 pseudogene 106.135714 106.137832 negative MGI_C57BL6J_3649750 Hspd1-ps4 NCBI_Gene:384039,ENSEMBL:ENSMUSG00000081189 MGI:3649750 pseudogene heat shock protein 1 (chaperonin), pseudogene 4
4 gene 106.237122 106.291000 positive MGI_C57BL6J_3649755 Gm12724 NCBI_Gene:105244641,ENSEMBL:ENSMUSG00000086249 MGI:3649755 lncRNA gene predicted gene 12724
4 pseudogene 106.257031 106.257298 positive MGI_C57BL6J_3649483 Gm12731 ENSEMBL:ENSMUSG00000082958 MGI:3649483 pseudogene predicted gene 12731
4 gene 106.291269 106.292255 positive MGI_C57BL6J_3651116 Gm12730 ENSEMBL:ENSMUSG00000087051 MGI:3651116 lncRNA gene predicted gene 12730
4 gene 106.293352 106.294393 negative MGI_C57BL6J_5610481 Gm37253 ENSEMBL:ENSMUSG00000104192 MGI:5610481 unclassified gene predicted gene, 37253
4 gene 106.314641 106.316152 negative MGI_C57BL6J_5589588 Gm30429 NCBI_Gene:102632328 MGI:5589588 lncRNA gene predicted gene, 30429
4 gene 106.316213 106.446575 positive MGI_C57BL6J_1919936 Usp24 NCBI_Gene:329908,ENSEMBL:ENSMUSG00000028514 MGI:1919936 protein coding gene ubiquitin specific peptidase 24
4 gene 106.324430 106.326355 positive MGI_C57BL6J_5623103 Gm40218 NCBI_Gene:105244642 MGI:5623103 lncRNA gene predicted gene, 40218
4 gene 106.442329 106.464329 negative MGI_C57BL6J_2140260 Pcsk9 NCBI_Gene:100102,ENSEMBL:ENSMUSG00000044254 MGI:2140260 protein coding gene proprotein convertase subtilisin/kexin type 9
4 gene 106.464629 106.477388 positive MGI_C57BL6J_5589646 Gm30487 NCBI_Gene:102632408 MGI:5589646 lncRNA gene predicted gene, 30487
4 gene 106.483456 106.492283 negative MGI_C57BL6J_2153465 Bsnd NCBI_Gene:140475,ENSEMBL:ENSMUSG00000025418 MGI:2153465 protein coding gene barttin CLCNK type accessory beta subunit
4 gene 106.498808 106.506335 negative MGI_C57BL6J_3041156 Tmem61 NCBI_Gene:329909,ENSEMBL:ENSMUSG00000085933 MGI:3041156 lincRNA gene transmembrane protein 61
4 gene 106.554669 106.557897 negative MGI_C57BL6J_1919813 2700068H02Rik ENSEMBL:ENSMUSG00000086172 MGI:1919813 lncRNA gene RIKEN cDNA 2700068H02 gene
4 gene 106.561038 106.589113 positive MGI_C57BL6J_1922004 Dhcr24 NCBI_Gene:74754,ENSEMBL:ENSMUSG00000034926 MGI:1922004 protein coding gene 24-dehydrocholesterol reductase
4 gene 106.587097 106.589108 negative MGI_C57BL6J_3702539 Gm12744 ENSEMBL:ENSMUSG00000085023 MGI:3702539 lncRNA gene predicted gene 12744
4 gene 106.590908 106.617500 negative MGI_C57BL6J_2681853 Lexm NCBI_Gene:242602,ENSEMBL:ENSMUSG00000054362 MGI:2681853 protein coding gene lymphocyte expansion molecule
4 gene 106.622432 106.640196 positive MGI_C57BL6J_3045307 Ttc22 NCBI_Gene:230576,ENSEMBL:ENSMUSG00000034919 MGI:3045307 protein coding gene tetratricopeptide repeat domain 22
4 gene 106.651022 106.655282 positive MGI_C57BL6J_2386296 Pars2 NCBI_Gene:230577,ENSEMBL:ENSMUSG00000043572 MGI:2386296 protein coding gene prolyl-tRNA synthetase (mitochondrial)(putative)
4 gene 106.658202 106.678969 negative MGI_C57BL6J_1919604 Ttc4 NCBI_Gene:72354,ENSEMBL:ENSMUSG00000025413 MGI:1919604 protein coding gene tetratricopeptide repeat domain 4
4 gene 106.680417 106.736616 negative MGI_C57BL6J_2685873 Mroh7 NCBI_Gene:381538,ENSEMBL:ENSMUSG00000047502 MGI:2685873 protein coding gene maestro heat-like repeat family member 7
4 gene 106.733889 106.748292 positive MGI_C57BL6J_2657115 Fam151a NCBI_Gene:230579,ENSEMBL:ENSMUSG00000034871 MGI:2657115 protein coding gene family with sequence simliarity 151, member A
4 gene 106.744555 106.806086 negative MGI_C57BL6J_1913736 Acot11 NCBI_Gene:329910,ENSEMBL:ENSMUSG00000034853 MGI:1913736 protein coding gene acyl-CoA thioesterase 11
4 pseudogene 106.774816 106.775029 positive MGI_C57BL6J_3651452 Gm12745 ENSEMBL:ENSMUSG00000081110 MGI:3651452 pseudogene predicted gene 12745
4 gene 106.814909 106.828344 negative MGI_C57BL6J_5590224 Gm31065 NCBI_Gene:102633170 MGI:5590224 lncRNA gene predicted gene, 31065
4 gene 106.839278 106.840161 negative MGI_C57BL6J_5590284 Gm31125 NCBI_Gene:102633257 MGI:5590284 lncRNA gene predicted gene, 31125
4 gene 106.841761 106.847920 negative MGI_C57BL6J_3652135 Gm12746 ENSEMBL:ENSMUSG00000086940 MGI:3652135 lncRNA gene predicted gene 12746
4 gene 106.900213 106.912896 negative MGI_C57BL6J_5826502 Gm46865 NCBI_Gene:108168970 MGI:5826502 lncRNA gene predicted gene, 46865
4 gene 106.910701 107.049694 positive MGI_C57BL6J_1919725 Ssbp3 NCBI_Gene:72475,ENSEMBL:ENSMUSG00000061887 MGI:1919725 protein coding gene single-stranded DNA binding protein 3
4 gene 107.017935 107.022499 negative MGI_C57BL6J_3650114 Gm12786 ENSEMBL:ENSMUSG00000085581 MGI:3650114 lncRNA gene predicted gene 12786
4 gene 107.055874 107.066868 negative MGI_C57BL6J_1926268 Mrpl37 NCBI_Gene:56280,ENSEMBL:ENSMUSG00000028622 MGI:1926268 protein coding gene mitochondrial ribosomal protein L37
4 gene 107.066910 107.088268 positive MGI_C57BL6J_1919657 Cyb5rl NCBI_Gene:230582,ENSEMBL:ENSMUSG00000028621 MGI:1919657 protein coding gene cytochrome b5 reductase-like
4 gene 107.096891 107.113125 positive MGI_C57BL6J_3045328 Cdcp2 NCBI_Gene:242603,ENSEMBL:ENSMUSG00000047636 MGI:3045328 protein coding gene CUB domain containing protein 2
4 gene 107.126613 107.136252 positive MGI_C57BL6J_3649683 Gm12802 ENSEMBL:ENSMUSG00000085304 MGI:3649683 lncRNA gene predicted gene 12802
4 gene 107.134155 107.179116 negative MGI_C57BL6J_1913776 Tceanc2 NCBI_Gene:66526,ENSEMBL:ENSMUSG00000028619 MGI:1913776 protein coding gene transcription elongation factor A (SII) N-terminal and central domain containing 2
4 gene 107.178399 107.200996 positive MGI_C57BL6J_1929278 Tmem59 NCBI_Gene:56374,ENSEMBL:ENSMUSG00000028618 MGI:1929278 protein coding gene transmembrane protein 59
4 gene 107.209078 107.221097 positive MGI_C57BL6J_3652166 Ldlrad1 NCBI_Gene:546840,ENSEMBL:ENSMUSG00000070877 MGI:3652166 protein coding gene low density lipoprotein receptor class A domain containing 1
4 gene 107.233514 107.253533 negative MGI_C57BL6J_1925059 Lrrc42 NCBI_Gene:77809,ENSEMBL:ENSMUSG00000028617 MGI:1925059 protein coding gene leucine rich repeat containing 42
4 gene 107.253593 107.284497 positive MGI_C57BL6J_1920188 Hspb11 NCBI_Gene:72938,ENSEMBL:ENSMUSG00000063172 MGI:1920188 protein coding gene heat shock protein family B (small), member 11
4 pseudogene 107.270434 107.270869 positive MGI_C57BL6J_3651240 Gm12850 ENSEMBL:ENSMUSG00000082941 MGI:3651240 pseudogene predicted gene 12850
4 gene 107.291465 107.307169 negative MGI_C57BL6J_94896 Dio1 NCBI_Gene:13370,ENSEMBL:ENSMUSG00000034785 MGI:94896 protein coding gene deiodinase, iodothyronine, type I
4 gene 107.314222 107.359823 positive MGI_C57BL6J_1915532 Yipf1 NCBI_Gene:230584,ENSEMBL:ENSMUSG00000057375 MGI:1915532 protein coding gene Yip1 domain family, member 1
4 pseudogene 107.326824 107.328529 negative MGI_C57BL6J_3649408 Gm12870 NCBI_Gene:652920,ENSEMBL:ENSMUSG00000082279 MGI:3649408 pseudogene predicted gene 12870
4 gene 107.349039 107.351353 negative MGI_C57BL6J_3649409 Gm12869 ENSEMBL:ENSMUSG00000086041 MGI:3649409 lncRNA gene predicted gene 12869
4 gene 107.367784 107.416346 positive MGI_C57BL6J_1920037 Ndc1 NCBI_Gene:72787,ENSEMBL:ENSMUSG00000028614 MGI:1920037 protein coding gene NDC1 transmembrane nucleoporin
4 gene 107.426637 107.635061 positive MGI_C57BL6J_2386723 Glis1 NCBI_Gene:230587,ENSEMBL:ENSMUSG00000034762 MGI:2386723 protein coding gene GLIS family zinc finger 1
4 gene 107.433777 107.434488 negative MGI_C57BL6J_5826503 Gm46866 NCBI_Gene:108168971 MGI:5826503 lncRNA gene predicted gene, 46866
4 gene 107.434572 107.434656 positive MGI_C57BL6J_5454581 Gm24804 ENSEMBL:ENSMUSG00000092723 MGI:5454581 miRNA gene predicted gene, 24804
4 gene 107.591846 107.601258 negative MGI_C57BL6J_1925456 4930552P06Rik NCBI_Gene:102633643 MGI:1925456 lncRNA gene RIKEN cDNA 4930552P06 gene
4 gene 107.676288 107.684253 negative MGI_C57BL6J_1927125 Dmrtb1 NCBI_Gene:56296,ENSEMBL:ENSMUSG00000028610 MGI:1927125 protein coding gene DMRT-like family B with proline-rich C-terminal, 1
4 pseudogene 107.688128 107.688709 positive MGI_C57BL6J_3650162 Gm12899 NCBI_Gene:100417388,ENSEMBL:ENSMUSG00000081916 MGI:3650162 pseudogene predicted gene 12899
4 gene 107.689600 107.758985 positive MGI_C57BL6J_1920570 1700047F07Rik NCBI_Gene:102633724,ENSEMBL:ENSMUSG00000085549 MGI:1920570 lncRNA gene RIKEN cDNA 1700047F07 gene
4 gene 107.697834 107.697954 negative MGI_C57BL6J_5454900 Gm25123 ENSEMBL:ENSMUSG00000094267 MGI:5454900 miRNA gene predicted gene, 25123
4 gene 107.698160 107.736535 negative MGI_C57BL6J_5590841 Gm31682 NCBI_Gene:102633989 MGI:5590841 lncRNA gene predicted gene, 31682
4 pseudogene 107.759440 107.760473 negative MGI_C57BL6J_3650884 Gm12906 NCBI_Gene:433743,ENSEMBL:ENSMUSG00000084874 MGI:3650884 pseudogene predicted gene 12906
4 gene 107.759510 107.770993 positive MGI_C57BL6J_3650882 Gm12907 NCBI_Gene:102634068,ENSEMBL:ENSMUSG00000087195 MGI:3650882 lncRNA gene predicted gene 12907
4 gene 107.783708 107.789921 positive MGI_C57BL6J_1914798 4933424M12Rik NCBI_Gene:67548,ENSEMBL:ENSMUSG00000087289 MGI:1914798 lncRNA gene RIKEN cDNA 4933424M12 gene
4 gene 107.793147 107.802171 negative MGI_C57BL6J_3651133 Lrp8os3 NCBI_Gene:105244644,ENSEMBL:ENSMUSG00000087200 MGI:3651133 bidirectional promoter lncRNA gene low density lipoprotein receptor-related protein 8, apolipoprotein e receptor, opposite strand 3
4 gene 107.801869 107.876840 positive MGI_C57BL6J_1340044 Lrp8 NCBI_Gene:16975,ENSEMBL:ENSMUSG00000028613 MGI:1340044 protein coding gene low density lipoprotein receptor-related protein 8, apolipoprotein e receptor
4 gene 107.804374 107.823191 negative MGI_C57BL6J_3588233 Lrp8os2 NCBI_Gene:619295,ENSEMBL:ENSMUSG00000073779 MGI:3588233 antisense lncRNA gene low density lipoprotein receptor-related protein 8, apolipoprotein e receptor, opposite strand 2
4 gene 107.827896 107.830844 negative MGI_C57BL6J_1925359 Lrp8os1 ENSEMBL:ENSMUSG00000028612 MGI:1925359 antisense lncRNA gene low density lipoprotein receptor-related protein 8, apolipoprotein e receptor, opposite strand 1
4 gene 107.879755 107.887424 positive MGI_C57BL6J_1330312 Magoh NCBI_Gene:17149,ENSEMBL:ENSMUSG00000028609 MGI:1330312 protein coding gene mago homolog, exon junction complex core component
4 gene 107.889785 107.899384 positive MGI_C57BL6J_1921348 Czib NCBI_Gene:74098,ENSEMBL:ENSMUSG00000028608 MGI:1921348 protein coding gene CXXC motif containing zinc binding protein
4 gene 107.903981 107.923610 negative MGI_C57BL6J_109176 Cpt2 NCBI_Gene:12896,ENSEMBL:ENSMUSG00000028607 MGI:109176 protein coding gene carnitine palmitoyltransferase 2
4 gene 107.937471 107.947374 positive MGI_C57BL6J_5623106 Gm40221 NCBI_Gene:105244646 MGI:5623106 lncRNA gene predicted gene, 40221
4 gene 107.953932 107.960721 positive MGI_C57BL6J_1924473 4930407G08Rik NCBI_Gene:77223,ENSEMBL:ENSMUSG00000086713 MGI:1924473 lncRNA gene RIKEN cDNA 4930407G08 gene
4 gene 107.968332 108.013532 positive MGI_C57BL6J_2444087 Slc1a7 NCBI_Gene:242607,ENSEMBL:ENSMUSG00000008932 MGI:2444087 protein coding gene solute carrier family 1 (glutamate transporter), member 7
4 gene 108.014791 108.096445 negative MGI_C57BL6J_2674939 Podn NCBI_Gene:242608,ENSEMBL:ENSMUSG00000028600 MGI:2674939 protein coding gene podocan
4 gene 108.041697 108.041800 negative MGI_C57BL6J_5453131 Gm23354 ENSEMBL:ENSMUSG00000089051 MGI:5453131 snRNA gene predicted gene, 23354
4 gene 108.043830 108.144998 negative MGI_C57BL6J_98254 Scp2 NCBI_Gene:20280,ENSEMBL:ENSMUSG00000028603 MGI:98254 protein coding gene sterol carrier protein 2, liver
4 gene 108.087357 108.087449 positive MGI_C57BL6J_5531386 Mir6397 miRBase:MI0021933,NCBI_Gene:102465213,ENSEMBL:ENSMUSG00000098980 MGI:5531386 miRNA gene microRNA 6397
4 gene 108.165437 108.179308 positive MGI_C57BL6J_1289238 Echdc2 NCBI_Gene:52430,ENSEMBL:ENSMUSG00000028601 MGI:1289238 protein coding gene enoyl Coenzyme A hydratase domain containing 2
4 gene 108.180245 108.218154 negative MGI_C57BL6J_2446208 Zyg11a NCBI_Gene:230590,ENSEMBL:ENSMUSG00000034645 MGI:2446208 protein coding gene zyg-11 family member A, cell cycle regulator
4 gene 108.217980 108.220462 positive MGI_C57BL6J_5623107 Gm40222 NCBI_Gene:105244647 MGI:5623107 lncRNA gene predicted gene, 40222
4 gene 108.227755 108.301138 negative MGI_C57BL6J_2685277 Zyg11b NCBI_Gene:414872,ENSEMBL:ENSMUSG00000034636 MGI:2685277 protein coding gene zyg-ll family member B, cell cycle regulator
4 pseudogene 108.310356 108.311151 negative MGI_C57BL6J_3651646 Gm12742 ENSEMBL:ENSMUSG00000083957 MGI:3651646 pseudogene predicted gene 12742
4 pseudogene 108.322338 108.322645 positive MGI_C57BL6J_3651641 Gm12740 ENSEMBL:ENSMUSG00000081734 MGI:3651641 pseudogene predicted gene 12740
4 gene 108.328140 108.341544 positive MGI_C57BL6J_1917143 Coa7 NCBI_Gene:69893,ENSEMBL:ENSMUSG00000048351 MGI:1917143 protein coding gene cytochrome c oxidase assembly factor 7
4 gene 108.345493 108.351197 negative MGI_C57BL6J_5826526 Gm46889 NCBI_Gene:108169005 MGI:5826526 lncRNA gene predicted gene, 46889
4 gene 108.367777 108.385780 negative MGI_C57BL6J_3651644 Shisal2a NCBI_Gene:545667,ENSEMBL:ENSMUSG00000059816 MGI:3651644 protein coding gene shisa like 2A
4 gene 108.383295 108.406608 positive MGI_C57BL6J_5591456 Gm32297 NCBI_Gene:105244648 MGI:5591456 lncRNA gene predicted gene, 32297
4 gene 108.400217 108.406961 negative MGI_C57BL6J_1914555 Gpx7 NCBI_Gene:67305,ENSEMBL:ENSMUSG00000028597 MGI:1914555 protein coding gene glutathione peroxidase 7
4 gene 108.430637 108.454167 positive MGI_C57BL6J_5623108 Gm40223 NCBI_Gene:105244650 MGI:5623108 lncRNA gene predicted gene, 40223
4 pseudogene 108.450710 108.451375 negative MGI_C57BL6J_3651217 Gm12738 NCBI_Gene:665728,ENSEMBL:ENSMUSG00000083255 MGI:3651217 pseudogene predicted gene 12738
4 gene 108.459426 108.560734 positive MGI_C57BL6J_2445126 Tut4 NCBI_Gene:230594,ENSEMBL:ENSMUSG00000034610 MGI:2445126 protein coding gene terminal uridylyl transferase 4
4 gene 108.466944 108.467050 negative MGI_C57BL6J_5454744 Gm24967 ENSEMBL:ENSMUSG00000095361 MGI:5454744 snRNA gene predicted gene, 24967
4 pseudogene 108.484064 108.484872 negative MGI_C57BL6J_3651018 Gm12739 NCBI_Gene:105244651,ENSEMBL:ENSMUSG00000083783 MGI:3651018 pseudogene predicted gene 12739
4 gene 108.498044 108.498146 positive MGI_C57BL6J_5452915 Gm23138 ENSEMBL:ENSMUSG00000065299 MGI:5452915 snRNA gene predicted gene, 23138
4 gene 108.513781 108.516817 positive MGI_C57BL6J_3651021 Gm12737 ENSEMBL:ENSMUSG00000085093 MGI:3651021 lncRNA gene predicted gene 12737
4 gene 108.521924 108.522030 negative MGI_C57BL6J_5455604 Gm25827 ENSEMBL:ENSMUSG00000087714 MGI:5455604 snRNA gene predicted gene, 25827
4 gene 108.537491 108.537597 negative MGI_C57BL6J_5452122 Gm22345 ENSEMBL:ENSMUSG00000084593 MGI:5452122 snRNA gene predicted gene, 22345
4 gene 108.563172 108.579336 negative MGI_C57BL6J_1916962 Prpf38a NCBI_Gene:230596,ENSEMBL:ENSMUSG00000063800 MGI:1916962 protein coding gene PRP38 pre-mRNA processing factor 38 (yeast) domain containing A
4 gene 108.575620 108.616030 positive MGI_C57BL6J_1328337 Orc1 NCBI_Gene:18392,ENSEMBL:ENSMUSG00000028587 MGI:1328337 protein coding gene origin recognition complex, subunit 1
4 gene 108.592425 108.619849 negative MGI_C57BL6J_3651449 Gm12743 ENSEMBL:ENSMUSG00000084968 MGI:3651449 lncRNA gene predicted gene 12743
4 gene 108.619767 108.635486 positive MGI_C57BL6J_2443076 Cc2d1b NCBI_Gene:319965,ENSEMBL:ENSMUSG00000028582 MGI:2443076 protein coding gene coiled-coil and C2 domain containing 1B
4 gene 108.622929 108.625216 negative MGI_C57BL6J_5313040 Gm20731 ENSEMBL:ENSMUSG00000102912 MGI:5313040 protein coding gene predicted gene, 20731
4 gene 108.633843 108.637441 negative MGI_C57BL6J_4936988 Gm17354 ENSEMBL:ENSMUSG00000091985 MGI:4936988 lncRNA gene predicted gene, 17354
4 gene 108.637466 108.782247 negative MGI_C57BL6J_2652838 Zfyve9 NCBI_Gene:230597,ENSEMBL:ENSMUSG00000034557 MGI:2652838 protein coding gene zinc finger, FYVE domain containing 9
4 gene 108.719649 108.781904 positive MGI_C57BL6J_1920383 3110021N24Rik ENSEMBL:ENSMUSG00000094958 MGI:1920383 protein coding gene RIKEN cDNA 3110021N24 gene
4 pseudogene 108.731715 108.732397 positive MGI_C57BL6J_3651642 Gm12741 NCBI_Gene:100040326,ENSEMBL:ENSMUSG00000082374 MGI:3651642 pseudogene predicted gene 12741
4 gene 108.814295 108.834297 negative MGI_C57BL6J_1915312 Btf3l4 NCBI_Gene:70533,ENSEMBL:ENSMUSG00000028568 MGI:1915312 protein coding gene basic transcription factor 3-like 4
4 gene 108.834601 108.862127 positive MGI_C57BL6J_1913323 Txndc12 NCBI_Gene:66073,ENSEMBL:ENSMUSG00000028567 MGI:1913323 protein coding gene thioredoxin domain containing 12 (endoplasmic reticulum)
4 gene 108.847399 108.848619 negative MGI_C57BL6J_3704235 A730015C16Rik NA NA lncRNA gene RIKEN cDNA A730015C16 gene
4 gene 108.847785 108.849413 positive MGI_C57BL6J_1923547 Kti12 NCBI_Gene:100087,ENSEMBL:ENSMUSG00000073775 MGI:1923547 protein coding gene KTI12 homolog, chromatin associated
4 gene 108.850866 108.852019 positive MGI_C57BL6J_1924896 C030043A13Rik NA NA unclassified gene RIKEN cDNA C030043A13 gene
4 gene 108.879063 108.943324 positive MGI_C57BL6J_1917158 Rab3b NCBI_Gene:69908,ENSEMBL:ENSMUSG00000003411 MGI:1917158 protein coding gene RAB3B, member RAS oncogene family
4 pseudogene 108.933573 108.933808 negative MGI_C57BL6J_3650723 Gm12736 ENSEMBL:ENSMUSG00000082699 MGI:3650723 pseudogene predicted gene 12736
4 gene 108.942843 108.972077 negative MGI_C57BL6J_1924423 8030443G20Rik NCBI_Gene:77173,ENSEMBL:ENSMUSG00000086483 MGI:1924423 lncRNA gene RIKEN cDNA 8030443G20 gene
4 gene 108.998602 108.998706 negative MGI_C57BL6J_5453366 Gm23589 ENSEMBL:ENSMUSG00000088285 MGI:5453366 snRNA gene predicted gene, 23589
4 gene 109.000614 109.061777 positive MGI_C57BL6J_1201386 Nrd1 NCBI_Gene:230598,ENSEMBL:ENSMUSG00000053510 MGI:1201386 protein coding gene nardilysin, N-arginine dibasic convertase, NRD convertase 1
4 gene 109.017655 109.017730 positive MGI_C57BL6J_3691609 Mir761 miRBase:MI0004306,NCBI_Gene:791075,ENSEMBL:ENSMUSG00000076444 MGI:3691609 miRNA gene microRNA 761
4 gene 109.061145 109.202272 negative MGI_C57BL6J_1923784 Osbpl9 NCBI_Gene:100273,ENSEMBL:ENSMUSG00000028559 MGI:1923784 protein coding gene oxysterol binding protein-like 9
4 gene 109.069808 109.070174 negative MGI_C57BL6J_1925486 5330417P21Rik NA NA unclassified gene RIKEN cDNA 5330417P21 gene
4 gene 109.078493 109.081224 positive MGI_C57BL6J_5591740 Gm32581 NCBI_Gene:102635178 MGI:5591740 lncRNA gene predicted gene, 32581
4 gene 109.102971 109.103526 negative MGI_C57BL6J_1924670 C030032G21Rik NA NA unclassified gene RIKEN cDNA C030032G21 gene
4 gene 109.160924 109.161197 negative MGI_C57BL6J_5453520 Gm23743 ENSEMBL:ENSMUSG00000088014 MGI:5453520 unclassified non-coding RNA gene predicted gene, 23743
4 gene 109.202193 109.208499 positive MGI_C57BL6J_5826504 Gm46867 NCBI_Gene:108168972 MGI:5826504 lncRNA gene predicted gene, 46867
4 gene 109.218413 109.255134 positive MGI_C57BL6J_2140435 Calr4 NCBI_Gene:108802,ENSEMBL:ENSMUSG00000028558 MGI:2140435 protein coding gene calreticulin 4
4 gene 109.224090 109.280108 negative MGI_C57BL6J_5623110 Gm40225 NCBI_Gene:105244653 MGI:5623110 lncRNA gene predicted gene, 40225
4 gene 109.280256 109.387817 positive MGI_C57BL6J_104583 Eps15 NCBI_Gene:13858,ENSEMBL:ENSMUSG00000028552 MGI:104583 protein coding gene epidermal growth factor receptor pathway substrate 15
4 gene 109.355440 109.360022 negative MGI_C57BL6J_5623109 Gm40224 NCBI_Gene:105244652 MGI:5623109 lncRNA gene predicted gene, 40224
4 pseudogene 109.373701 109.374936 negative MGI_C57BL6J_3652196 Gm12749 NCBI_Gene:666144,ENSEMBL:ENSMUSG00000083512 MGI:3652196 pseudogene predicted gene 12749
4 gene 109.394147 109.444745 positive MGI_C57BL6J_2444350 Ttc39a NCBI_Gene:230603,ENSEMBL:ENSMUSG00000028555 MGI:2444350 protein coding gene tetratricopeptide repeat domain 39A
4 gene 109.402279 109.406257 negative MGI_C57BL6J_3651956 Ttc39aos1 NCBI_Gene:102635290,ENSEMBL:ENSMUSG00000085873 MGI:3651956 antisense lncRNA gene Ttc39a opposite strand RNA 1
4 gene 109.451098 109.484728 negative MGI_C57BL6J_1352759 Rnf11 NCBI_Gene:29864,ENSEMBL:ENSMUSG00000028557 MGI:1352759 protein coding gene ring finger protein 11
4 gene 109.505332 109.531297 negative MGI_C57BL6J_1914896 4930522H14Rik NCBI_Gene:67646,ENSEMBL:ENSMUSG00000060491 MGI:1914896 protein coding gene RIKEN cDNA 4930522H14 gene
4 gene 109.537039 109.537169 positive MGI_C57BL6J_5452274 Gm22497 ENSEMBL:ENSMUSG00000077687 MGI:5452274 snoRNA gene predicted gene, 22497
4 gene 109.550959 109.554048 positive MGI_C57BL6J_5623111 Gm40226 NCBI_Gene:105244654 MGI:5623111 lncRNA gene predicted gene, 40226
4 gene 109.569214 109.656791 positive MGI_C57BL6J_3650795 Gm12811 ENSEMBL:ENSMUSG00000087641 MGI:3650795 lncRNA gene predicted gene 12811
4 pseudogene 109.599375 109.600047 negative MGI_C57BL6J_5011297 Gm19112 NCBI_Gene:100418274 MGI:5011297 pseudogene predicted gene, 19112
4 pseudogene 109.629582 109.630857 positive MGI_C57BL6J_3651634 Gm12803 NCBI_Gene:100418450,ENSEMBL:ENSMUSG00000082771 MGI:3651634 pseudogene predicted gene 12803
4 gene 109.630879 109.649103 negative MGI_C57BL6J_5623112 Gm40227 NCBI_Gene:105244655 MGI:5623112 lncRNA gene predicted gene, 40227
4 gene 109.651529 109.657853 negative MGI_C57BL6J_2442649 9630013D21Rik NCBI_Gene:319743,ENSEMBL:ENSMUSG00000059027 MGI:2442649 lncRNA gene RIKEN cDNA 9630013D21 gene
4 gene 109.660876 109.667189 negative MGI_C57BL6J_105388 Cdkn2c NCBI_Gene:12580,ENSEMBL:ENSMUSG00000028551 MGI:105388 protein coding gene cyclin dependent kinase inhibitor 2C
4 gene 109.666870 109.668249 negative MGI_C57BL6J_3826683 Gm2703 NA NA protein coding gene predicted gene 2703
4 gene 109.676588 109.963960 positive MGI_C57BL6J_109419 Faf1 NCBI_Gene:14084,ENSEMBL:ENSMUSG00000010517 MGI:109419 protein coding gene Fas-associated factor 1
4 pseudogene 109.754414 109.754817 negative MGI_C57BL6J_3650597 Gm12808 ENSEMBL:ENSMUSG00000083995 MGI:3650597 pseudogene predicted gene 12808
4 gene 109.973179 109.977813 negative MGI_C57BL6J_1924703 Dmrta2os NCBI_Gene:77453,ENSEMBL:ENSMUSG00000085256 MGI:1924703 antisense lncRNA gene doublesex and mab-3 related transcription factor like family A2, opposite strand
4 gene 109.977782 109.983699 positive MGI_C57BL6J_2653629 Dmrta2 NCBI_Gene:242620,ENSEMBL:ENSMUSG00000047143 MGI:2653629 protein coding gene doublesex and mab-3 related transcription factor like family A2
4 gene 110.152666 110.156713 positive MGI_C57BL6J_5592229 Gm33070 NCBI_Gene:102635827 MGI:5592229 lncRNA gene predicted gene, 33070
4 gene 110.203722 110.351911 negative MGI_C57BL6J_107427 Elavl4 NCBI_Gene:15572,ENSEMBL:ENSMUSG00000028546 MGI:107427 protein coding gene ELAV like RNA binding protein 4
4 gene 110.397639 111.664324 positive MGI_C57BL6J_1918244 Agbl4 NCBI_Gene:78933,ENSEMBL:ENSMUSG00000061298 MGI:1918244 protein coding gene ATP/GTP binding protein-like 4
4 gene 110.434802 110.435991 positive MGI_C57BL6J_1924569 C030007D22Rik NA NA unclassified gene RIKEN cDNA C030007D22 gene
4 pseudogene 110.510035 110.510302 positive MGI_C57BL6J_3651080 Gm12806 ENSEMBL:ENSMUSG00000081813 MGI:3651080 pseudogene predicted gene 12806
4 pseudogene 110.512763 110.514256 negative MGI_C57BL6J_3650599 Gm12807 NCBI_Gene:102635892,ENSEMBL:ENSMUSG00000082348 MGI:3650599 pseudogene predicted gene 12807
4 pseudogene 111.290118 111.291116 positive MGI_C57BL6J_3651639 Gm12804 NCBI_Gene:100417659,ENSEMBL:ENSMUSG00000081068 MGI:3651639 pseudogene predicted gene 12804
4 pseudogene 111.319547 111.320626 negative MGI_C57BL6J_3650124 Gm12805 NCBI_Gene:100417245,ENSEMBL:ENSMUSG00000083904 MGI:3650124 pseudogene predicted gene 12805
4 gene 111.413794 111.460298 positive MGI_C57BL6J_1914871 Bend5 NCBI_Gene:67621,ENSEMBL:ENSMUSG00000028545 MGI:1914871 protein coding gene BEN domain containing 5
4 gene 111.427818 111.427933 negative MGI_C57BL6J_4422056 n-R5s191 ENSEMBL:ENSMUSG00000084673 MGI:4422056 rRNA gene nuclear encoded rRNA 5S 191
4 gene 111.695614 111.723986 negative MGI_C57BL6J_5592351 Gm33192 NCBI_Gene:102635996 MGI:5592351 lncRNA gene predicted gene, 33192
4 gene 111.719949 111.829184 positive MGI_C57BL6J_1915196 Spata6 NCBI_Gene:67946,ENSEMBL:ENSMUSG00000034401 MGI:1915196 protein coding gene spermatogenesis associated 6
4 pseudogene 111.790621 111.791673 negative MGI_C57BL6J_3650787 Gm12961 NCBI_Gene:100417901,ENSEMBL:ENSMUSG00000082686 MGI:3650787 pseudogene predicted gene 12961
4 pseudogene 111.807001 111.808483 negative MGI_C57BL6J_3651525 Gm12960 NCBI_Gene:105244657,ENSEMBL:ENSMUSG00000100514 MGI:3651525 pseudogene predicted gene 12960
4 gene 111.875374 111.902918 negative MGI_C57BL6J_2140201 Slc5a9 NCBI_Gene:230612,ENSEMBL:ENSMUSG00000028544 MGI:2140201 protein coding gene solute carrier family 5 (sodium/glucose cotransporter), member 9
4 gene 111.919392 111.950361 positive MGI_C57BL6J_3651523 Skint8 NCBI_Gene:639774,ENSEMBL:ENSMUSG00000078599 MGI:3651523 protein coding gene selection and upkeep of intraepithelial T cells 8
4 gene 111.972923 111.988260 positive MGI_C57BL6J_3041190 Skint7 NCBI_Gene:328505,ENSEMBL:ENSMUSG00000049214 MGI:3041190 protein coding gene selection and upkeep of intraepithelial T cells 7
4 gene 111.988650 111.988958 negative MGI_C57BL6J_5455621 Gm25844 ENSEMBL:ENSMUSG00000084536 MGI:5455621 unclassified non-coding RNA gene predicted gene, 25844
4 gene 112.006269 112.029538 positive MGI_C57BL6J_3649627 Skint1 NCBI_Gene:639781,ENSEMBL:ENSMUSG00000089773 MGI:3649627 protein coding gene selection and upkeep of intraepithelial T cells 1
4 gene 112.072016 112.168076 positive MGI_C57BL6J_2444425 Skint4 NCBI_Gene:320640,ENSEMBL:ENSMUSG00000055960 MGI:2444425 protein coding gene selection and upkeep of intraepithelial T cells 4
4 pseudogene 112.121003 112.121344 negative MGI_C57BL6J_3652018 Gm12820 ENSEMBL:ENSMUSG00000084326 MGI:3652018 pseudogene predicted gene 12820
4 pseudogene 112.146098 112.146232 negative MGI_C57BL6J_3652016 Gm12815 ENSEMBL:ENSMUSG00000082638 MGI:3652016 pseudogene predicted gene 12815
4 gene 112.232245 112.300468 positive MGI_C57BL6J_3045331 Skint3 NCBI_Gene:195564,ENSEMBL:ENSMUSG00000070868 MGI:3045331 protein coding gene selection and upkeep of intraepithelial T cells 3
4 gene 112.385969 112.433985 negative MGI_C57BL6J_3045341 Skint9 NCBI_Gene:329918,ENSEMBL:ENSMUSG00000049972 MGI:3045341 protein coding gene selection and upkeep of intraepithelial T cells 9
4 pseudogene 112.473829 112.521531 positive MGI_C57BL6J_3652017 Gm12819 NCBI_Gene:100504555,ENSEMBL:ENSMUSG00000081166 MGI:3652017 pseudogene predicted gene 12819
4 pseudogene 112.537061 112.537707 positive MGI_C57BL6J_3649625 Gm12821 NCBI_Gene:102636060,ENSEMBL:ENSMUSG00000083599 MGI:3649625 pseudogene predicted gene 12821
4 gene 112.557194 112.652248 positive MGI_C57BL6J_3649629 Skint2 NCBI_Gene:329919,ENSEMBL:ENSMUSG00000034359 MGI:3649629 protein coding gene selection and upkeep of intraepithelial T cells 2
4 pseudogene 112.559746 112.593301 positive MGI_C57BL6J_3651208 Gm12814 NCBI_Gene:630887,ENSEMBL:ENSMUSG00000083753 MGI:3651208 pseudogene predicted gene 12814
4 gene 112.590772 112.590878 negative MGI_C57BL6J_5453876 Gm24099 ENSEMBL:ENSMUSG00000096564 MGI:5453876 snRNA gene predicted gene, 24099
4 pseudogene 112.705142 112.706239 positive MGI_C57BL6J_3649633 Gm12817 NCBI_Gene:100040581,ENSEMBL:ENSMUSG00000081066 MGI:3649633 pseudogene predicted gene 12817
4 gene 112.710830 112.774866 negative MGI_C57BL6J_2685416 Skint10 NCBI_Gene:230613,ENSEMBL:ENSMUSG00000048766 MGI:2685416 protein coding gene selection and upkeep of intraepithelial T cells 10
4 pseudogene 112.772092 112.773268 positive MGI_C57BL6J_5010585 Gm18400 NCBI_Gene:100417108 MGI:5010585 pseudogene predicted gene, 18400
4 gene 112.804503 113.286973 negative MGI_C57BL6J_3649262 Skint6 NCBI_Gene:230622,ENSEMBL:ENSMUSG00000087194 MGI:3649262 protein coding gene selection and upkeep of intraepithelial T cells 6
4 gene 112.923696 112.945317 positive MGI_C57BL6J_3651665 Gm12823 ENSEMBL:ENSMUSG00000085878 MGI:3651665 lncRNA gene predicted gene 12823
4 pseudogene 112.955008 112.956289 negative MGI_C57BL6J_3649628 Gm12816 NCBI_Gene:433745,ENSEMBL:ENSMUSG00000083011 MGI:3649628 pseudogene predicted gene 12816
4 pseudogene 112.978465 112.979843 negative MGI_C57BL6J_3649634 Gm12818 NCBI_Gene:100534383,ENSEMBL:ENSMUSG00000082678 MGI:3649634 pseudogene predicted gene 12818
4 pseudogene 113.368187 113.394502 positive MGI_C57BL6J_3650999 Gm12813 NCBI_Gene:100040607,ENSEMBL:ENSMUSG00000083384 MGI:3650999 pseudogene predicted gene 12813
4 gene 113.477860 113.999506 negative MGI_C57BL6J_3650151 Skint5 NCBI_Gene:242627,ENSEMBL:ENSMUSG00000078598 MGI:3650151 protein coding gene selection and upkeep of intraepithelial T cells 5
4 pseudogene 114.096322 114.097444 negative MGI_C57BL6J_3650153 Gm12825 NCBI_Gene:100418129,ENSEMBL:ENSMUSG00000080696 MGI:3650153 pseudogene predicted gene 12825
4 gene 114.163384 114.245028 positive MGI_C57BL6J_2685415 Skint11 NCBI_Gene:230623,ENSEMBL:ENSMUSG00000057977 MGI:2685415 protein coding gene selection and upkeep of intraepithelial T cells 11
4 pseudogene 114.165114 114.165910 negative MGI_C57BL6J_3783183 Gm15741 NCBI_Gene:100417107,ENSEMBL:ENSMUSG00000082825 MGI:3783183 pseudogene predicted gene 15741
4 gene 114.329906 114.346623 negative MGI_C57BL6J_5623113 Gm40228 NCBI_Gene:105244658 MGI:5623113 lncRNA gene predicted gene, 40228
4 gene 114.406197 114.615098 positive MGI_C57BL6J_3650152 Trabd2b NCBI_Gene:666048,ENSEMBL:ENSMUSG00000070867 MGI:3650152 protein coding gene TraB domain containing 2B
4 gene 114.413971 114.414949 negative MGI_C57BL6J_5592869 Gm33710 NCBI_Gene:102636714 MGI:5592869 lncRNA gene predicted gene, 33710
4 gene 114.576917 114.592223 negative MGI_C57BL6J_5592814 Gm33655 NCBI_Gene:102636647 MGI:5592814 lncRNA gene predicted gene, 33655
4 gene 114.672697 114.673340 negative MGI_C57BL6J_5579570 Gm28864 ENSEMBL:ENSMUSG00000100998 MGI:5579570 lncRNA gene predicted gene 28864
4 gene 114.680340 114.687595 positive MGI_C57BL6J_3650003 Gm12829 NCBI_Gene:102636500,ENSEMBL:ENSMUSG00000085870 MGI:3650003 lncRNA gene predicted gene 12829
4 gene 114.816093 114.902859 negative MGI_C57BL6J_1918862 9130410C08Rik NCBI_Gene:105244659,ENSEMBL:ENSMUSG00000085323 MGI:1918862 lncRNA gene RIKEN cDNA 9130410C08 gene
4 gene 114.821720 114.856166 positive MGI_C57BL6J_3649998 Gm12830 NCBI_Gene:433746,ENSEMBL:ENSMUSG00000055198 MGI:3649998 protein coding gene predicted gene 12830
4 gene 114.844985 114.845117 negative MGI_C57BL6J_5453007 Gm23230 ENSEMBL:ENSMUSG00000087923 MGI:5453007 snRNA gene predicted gene, 23230
4 gene 114.906280 114.908898 negative MGI_C57BL6J_1347471 Foxd2 NCBI_Gene:17301,ENSEMBL:ENSMUSG00000055210 MGI:1347471 protein coding gene forkhead box D2
4 gene 114.909257 114.921967 positive MGI_C57BL6J_2444065 Foxd2os NCBI_Gene:100040736,ENSEMBL:ENSMUSG00000085399 MGI:2444065 lncRNA gene forkhead box D2, opposite strand
4 gene 114.925147 114.926013 negative MGI_C57BL6J_1353569 Foxe3 NCBI_Gene:30923,ENSEMBL:ENSMUSG00000044518 MGI:1353569 protein coding gene forkhead box E3
4 gene 114.946813 114.950848 negative MGI_C57BL6J_5623114 Gm40229 NCBI_Gene:105244660 MGI:5623114 lncRNA gene predicted gene, 40229
4 gene 114.959336 114.987241 negative MGI_C57BL6J_1913838 Cmpk1 NCBI_Gene:66588,ENSEMBL:ENSMUSG00000028719 MGI:1913838 protein coding gene cytidine monophosphate (UMP-CMP) kinase 1
4 gene 114.987964 114.988061 positive MGI_C57BL6J_5453822 Gm24045 ENSEMBL:ENSMUSG00000065047 MGI:5453822 unclassified non-coding RNA gene predicted gene, 24045
4 gene 115.000108 115.043203 positive MGI_C57BL6J_107477 Stil NCBI_Gene:20460,ENSEMBL:ENSMUSG00000028718 MGI:107477 protein coding gene Scl/Tal1 interrupting locus
4 gene 115.056426 115.071755 positive MGI_C57BL6J_98480 Tal1 NCBI_Gene:21349,ENSEMBL:ENSMUSG00000028717 MGI:98480 protein coding gene T cell acute lymphocytic leukemia 1
4 gene 115.057622 115.058223 negative MGI_C57BL6J_5592945 Gm33786 NCBI_Gene:102636820 MGI:5592945 lncRNA gene predicted gene, 33786
4 gene 115.088708 115.093899 positive MGI_C57BL6J_1914432 Pdzk1ip1 NCBI_Gene:67182,ENSEMBL:ENSMUSG00000028716 MGI:1914432 protein coding gene PDZK1 interacting protein 1
4 gene 115.106323 115.134281 negative MGI_C57BL6J_1932403 Cyp4x1 NCBI_Gene:81906,ENSEMBL:ENSMUSG00000047155 MGI:1932403 protein coding gene cytochrome P450, family 4, subfamily x, polypeptide 1
4 gene 115.133832 115.137864 positive MGI_C57BL6J_3649427 Cyp4x1os NCBI_Gene:105244662,ENSEMBL:ENSMUSG00000086896 MGI:3649427 antisense lncRNA gene cytochrome P450, family 4, subfamily x, polypeptide 1, opposite strand
4 pseudogene 115.138564 115.156506 negative MGI_C57BL6J_1932405 Cyp4a28-ps NCBI_Gene:547220,ENSEMBL:ENSMUSG00000081823 MGI:1932405 pseudogene cytochrome P450, family 4, subfamily a, polypeptide 28, pseudogene
4 pseudogene 115.175798 115.176843 positive MGI_C57BL6J_3651920 Cyp4a29-ps1 ENSEMBL:ENSMUSG00000082889 MGI:3651920 pseudogene cytochrome P450, family 4, subfamily a, polypeptide 29, pseudogene 1
4 pseudogene 115.238754 115.241582 negative MGI_C57BL6J_3649428 Gm12834 NCBI_Gene:384042,ENSEMBL:ENSMUSG00000081138 MGI:3649428 pseudogene predicted gene 12834
4 gene 115.242084 115.254557 positive MGI_C57BL6J_3717143 Cyp4a29 NCBI_Gene:230639,ENSEMBL:ENSMUSG00000083138 MGI:3717143 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 29
4 gene 115.299046 115.332815 positive MGI_C57BL6J_88612 Cyp4a12a NCBI_Gene:277753,ENSEMBL:ENSMUSG00000066071 MGI:88612 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 12a
4 pseudogene 115.343788 115.363115 positive MGI_C57BL6J_3649426 Cyp4a30-ps NCBI_Gene:546842,ENSEMBL:ENSMUSG00000083190 MGI:3649426 pseudogene cytochrome P450, family 4, subfamily a, member 30, pseudogene
4 gene 115.411624 115.439034 positive MGI_C57BL6J_3611747 Cyp4a12b NCBI_Gene:13118,ENSEMBL:ENSMUSG00000078597 MGI:3611747 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 12B
4 pseudogene 115.416082 115.416454 negative MGI_C57BL6J_3649425 Gm12837 ENSEMBL:ENSMUSG00000084415 MGI:3649425 pseudogene predicted gene 12837
4 gene 115.452491 115.471418 positive MGI_C57BL6J_3717145 Cyp4a30b NCBI_Gene:435802,ENSEMBL:ENSMUSG00000084346 MGI:3717145 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 30b
4 pseudogene 115.453792 115.454116 negative MGI_C57BL6J_3649431 Gm12838 ENSEMBL:ENSMUSG00000080142 MGI:3649431 pseudogene predicted gene 12838
4 pseudogene 115.479539 115.481282 positive MGI_C57BL6J_3651919 Gm12833 NCBI_Gene:230641,ENSEMBL:ENSMUSG00000086724 MGI:3651919 pseudogene predicted gene 12833
4 gene 115.486200 115.496159 negative MGI_C57BL6J_1096550 Cyp4a14 NCBI_Gene:13119,ENSEMBL:ENSMUSG00000028715 MGI:1096550 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 14
4 gene 115.518264 115.533649 positive MGI_C57BL6J_88611 Cyp4a10 NCBI_Gene:13117,ENSEMBL:ENSMUSG00000066072 MGI:88611 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 10
4 pseudogene 115.543384 115.545069 negative MGI_C57BL6J_3651921 Cyp4b1-ps1 NCBI_Gene:100418216,ENSEMBL:ENSMUSG00000081006 MGI:3651921 pseudogene cytochrome P450, family 4, subfamily b, polypeptide 1, pseudogene 1
4 gene 115.563626 115.579015 positive MGI_C57BL6J_3028580 Cyp4a31 NCBI_Gene:666168,ENSEMBL:ENSMUSG00000028712 MGI:3028580 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 31
4 pseudogene 115.582038 115.583144 negative MGI_C57BL6J_3649236 Cyp4b1-ps2 NCBI_Gene:631037,ENSEMBL:ENSMUSG00000083457 MGI:3649236 pseudogene cytochrome P450, family 4, subfamily b, polypeptide 1, pseudogene 2
4 gene 115.600925 115.622507 positive MGI_C57BL6J_3717148 Cyp4a32 NCBI_Gene:100040843,ENSEMBL:ENSMUSG00000063929 MGI:3717148 protein coding gene cytochrome P450, family 4, subfamily a, polypeptide 32
4 gene 115.624725 115.647723 negative MGI_C57BL6J_103225 Cyp4b1 NCBI_Gene:13120,ENSEMBL:ENSMUSG00000028713 MGI:103225 protein coding gene cytochrome P450, family 4, subfamily b, polypeptide 1
4 pseudogene 115.652389 115.653480 positive MGI_C57BL6J_3650820 Gm12848 NCBI_Gene:546843,ENSEMBL:ENSMUSG00000082043 MGI:3650820 pseudogene predicted gene 12848
4 pseudogene 115.707251 115.708303 positive MGI_C57BL6J_3650623 Gm12849 ENSEMBL:ENSMUSG00000081172 MGI:3650623 pseudogene predicted gene 12849
4 gene 115.737744 115.777328 positive MGI_C57BL6J_2442397 Efcab14 NCBI_Gene:230648,ENSEMBL:ENSMUSG00000034210 MGI:2442397 protein coding gene EF-hand calcium binding domain 14
4 gene 115.779831 115.782750 negative MGI_C57BL6J_1922423 Tex38 NCBI_Gene:75173,ENSEMBL:ENSMUSG00000044556 MGI:1922423 protein coding gene testis expressed 38
4 gene 115.784812 115.818828 positive MGI_C57BL6J_2180560 Atpaf1 NCBI_Gene:230649,ENSEMBL:ENSMUSG00000028710 MGI:2180560 protein coding gene ATP synthase mitochondrial F1 complex assembly factor 1
4 gene 115.818857 115.822655 positive MGI_C57BL6J_3650822 Gm12847 ENSEMBL:ENSMUSG00000085249 MGI:3650822 lncRNA gene predicted gene 12847
4 gene 115.827886 115.836185 positive MGI_C57BL6J_2140623 Mob3c NCBI_Gene:100465,ENSEMBL:ENSMUSG00000028709 MGI:2140623 protein coding gene MOB kinase activator 3C
4 gene 115.838990 115.879256 positive MGI_C57BL6J_894316 Mknk1 NCBI_Gene:17346,ENSEMBL:ENSMUSG00000028708 MGI:894316 protein coding gene MAP kinase-interacting serine/threonine kinase 1
4 gene 115.878317 115.878576 negative MGI_C57BL6J_5580140 Gm29434 ENSEMBL:ENSMUSG00000100081 MGI:5580140 lncRNA gene predicted gene 29434
4 gene 115.884400 115.889526 positive MGI_C57BL6J_3614952 Kncn NCBI_Gene:654462,ENSEMBL:ENSMUSG00000073774 MGI:3614952 protein coding gene kinocilin
4 gene 115.890665 115.899228 positive MGI_C57BL6J_1923487 6430628N08Rik NCBI_Gene:76237,ENSEMBL:ENSMUSG00000034185 MGI:1923487 protein coding gene RIKEN cDNA 6430628N08 gene
4 gene 115.915119 115.940600 negative MGI_C57BL6J_2153518 Dmbx1 NCBI_Gene:140477,ENSEMBL:ENSMUSG00000028707 MGI:2153518 protein coding gene diencephalon/mesencephalon homeobox 1
4 gene 115.967139 115.970925 negative MGI_C57BL6J_5621377 Gm38492 NCBI_Gene:102637048 MGI:5621377 lncRNA gene predicted gene, 38492
4 gene 115.967145 116.018695 negative MGI_C57BL6J_109609 Faah NCBI_Gene:14073,ENSEMBL:ENSMUSG00000034171 MGI:109609 protein coding gene fatty acid amide hydrolase
4 gene 116.031770 116.053876 negative MGI_C57BL6J_1919431 Nsun4 NCBI_Gene:72181,ENSEMBL:ENSMUSG00000028706 MGI:1919431 protein coding gene NOL1/NOP2/Sun domain family, member 4
4 gene 116.066965 116.075071 negative MGI_C57BL6J_1913826 Uqcrh NCBI_Gene:66576,ENSEMBL:ENSMUSG00000063882 MGI:1913826 protein coding gene ubiquinol-cytochrome c reductase hinge protein
4 pseudogene 116.067179 116.067696 positive MGI_C57BL6J_3650410 Gm12854 NCBI_Gene:102637129,ENSEMBL:ENSMUSG00000078238 MGI:3650410 pseudogene predicted gene 12854
4 gene 116.075269 116.097109 positive MGI_C57BL6J_2441984 Lrrc41 NCBI_Gene:230654,ENSEMBL:ENSMUSG00000028703 MGI:2441984 protein coding gene leucine rich repeat containing 41
4 gene 116.094261 116.123690 negative MGI_C57BL6J_894697 Rad54l NCBI_Gene:19366,ENSEMBL:ENSMUSG00000028702 MGI:894697 protein coding gene RAD54 like (S. cerevisiae)
4 gene 116.123840 116.138841 positive MGI_C57BL6J_1924036 2510003B16Rik NCBI_Gene:76786 MGI:1924036 lncRNA gene RIKEN cDNA 2510003B16 gene
4 gene 116.123840 116.159849 positive MGI_C57BL6J_1915523 Pomgnt1 NCBI_Gene:68273,ENSEMBL:ENSMUSG00000028700 MGI:1915523 protein coding gene protein O-linked mannose beta 1,2-N-acetylglucosaminyltransferase
4 gene 116.132406 116.151338 negative MGI_C57BL6J_1915325 Lurap1 NCBI_Gene:68075,ENSEMBL:ENSMUSG00000028701 MGI:1915325 protein coding gene leucine rich adaptor protein 1
4 gene 116.161869 116.167621 negative MGI_C57BL6J_1914055 Tspan1 NCBI_Gene:66805,ENSEMBL:ENSMUSG00000028699 MGI:1914055 protein coding gene tetraspanin 1
4 gene 116.173372 116.174297 positive MGI_C57BL6J_1914573 1700042G07Rik NCBI_Gene:67323,ENSEMBL:ENSMUSG00000078593 MGI:1914573 protein coding gene RIKEN cDNA 1700042G07 gene
4 gene 116.173384 116.299841 positive MGI_C57BL6J_6121526 Gm49337 ENSEMBL:ENSMUSG00000111410 MGI:6121526 protein coding gene predicted gene, 49337
4 gene 116.176246 116.177732 positive MGI_C57BL6J_3649505 Gm12951 ENSEMBL:ENSMUSG00000085920 MGI:3649505 lncRNA gene predicted gene 12951
4 pseudogene 116.200405 116.200992 negative MGI_C57BL6J_3649506 Llph-ps1 NCBI_Gene:433748,ENSEMBL:ENSMUSG00000081459 MGI:3649506 pseudogene LLP homolog, pseudogene 1
4 gene 116.221421 116.303056 positive MGI_C57BL6J_109277 Pik3r3 NCBI_Gene:18710,ENSEMBL:ENSMUSG00000028698 MGI:109277 protein coding gene phosphoinositide-3-kinase regulatory subunit 3
4 pseudogene 116.250023 116.251106 negative MGI_C57BL6J_5010720 Gm18535 NCBI_Gene:100417330 MGI:5010720 pseudogene predicted gene, 18535
4 gene 116.306760 116.464254 negative MGI_C57BL6J_894676 Mast2 NCBI_Gene:17776,ENSEMBL:ENSMUSG00000003810 MGI:894676 protein coding gene microtubule associated serine/threonine kinase 2
4 gene 116.382322 116.385746 negative MGI_C57BL6J_2444793 A630078A22Rik NA NA unclassified gene RIKEN cDNA A630078A22 gene
4 pseudogene 116.448788 116.449204 positive MGI_C57BL6J_3649504 Gm12950 ENSEMBL:ENSMUSG00000082592 MGI:3649504 pseudogene predicted gene 12950
4 gene 116.507509 116.542563 positive MGI_C57BL6J_96581 Ipp NCBI_Gene:16351,ENSEMBL:ENSMUSG00000028696 MGI:96581 protein coding gene IAP promoted placental gene
4 gene 116.551528 116.557041 negative MGI_C57BL6J_3045357 Tmem69 NCBI_Gene:230657,ENSEMBL:ENSMUSG00000055900 MGI:3045357 protein coding gene transmembrane protein 69
4 gene 116.551740 116.552627 positive MGI_C57BL6J_3649497 Gm12953 ENSEMBL:ENSMUSG00000087299 MGI:3649497 lncRNA gene predicted gene 12953
4 gene 116.557155 116.593882 positive MGI_C57BL6J_1924360 Gpbp1l1 NCBI_Gene:77110,ENSEMBL:ENSMUSG00000034042 MGI:1924360 protein coding gene GC-rich promoter binding protein 1-like 1
4 gene 116.589733 116.597630 negative MGI_C57BL6J_3612454 C530005A16Rik NCBI_Gene:654318,ENSEMBL:ENSMUSG00000085408 MGI:3612454 lncRNA gene RIKEN cDNA C530005A16 gene
4 gene 116.596654 116.600266 positive MGI_C57BL6J_1915667 Ccdc17 NCBI_Gene:622665,ENSEMBL:ENSMUSG00000034035 MGI:1915667 protein coding gene coiled-coil domain containing 17
4 gene 116.601052 116.627951 negative MGI_C57BL6J_1355328 Nasp NCBI_Gene:50927,ENSEMBL:ENSMUSG00000028693 MGI:1355328 protein coding gene nuclear autoantigenic sperm protein (histone-binding)
4 gene 116.626843 116.628687 positive MGI_C57BL6J_2441802 A430091L06Rik NA NA unclassified gene RIKEN cDNA A430091L06 gene
4 gene 116.636510 116.651680 negative MGI_C57BL6J_1929955 Akr1a1 NCBI_Gene:58810,ENSEMBL:ENSMUSG00000028692 MGI:1929955 protein coding gene aldo-keto reductase family 1, member A1 (aldehyde reductase)
4 gene 116.674153 116.674262 positive MGI_C57BL6J_5454914 Gm25137 ENSEMBL:ENSMUSG00000065185 MGI:5454914 snRNA gene predicted gene, 25137
4 gene 116.685544 116.700822 positive MGI_C57BL6J_99523 Prdx1 NCBI_Gene:18477,ENSEMBL:ENSMUSG00000028691 MGI:99523 protein coding gene peroxiredoxin 1
4 gene 116.697077 116.697507 positive MGI_C57BL6J_1924686 9530001N24Rik NA NA unclassified gene RIKEN cDNA 9530001N24 gene
4 gene 116.702279 116.708406 negative MGI_C57BL6J_1914346 Mmachc NCBI_Gene:67096,ENSEMBL:ENSMUSG00000028690 MGI:1914346 protein coding gene methylmalonic aciduria cblC type, with homocystinuria
4 gene 116.708125 116.708432 positive MGI_C57BL6J_1925287 4930565M07Rik NA NA unclassified gene RIKEN cDNA 4930565M07 gene
4 gene 116.708509 116.751206 positive MGI_C57BL6J_1915644 Ccdc163 NCBI_Gene:68394,ENSEMBL:ENSMUSG00000028689 MGI:1915644 protein coding gene coiled-coil domain containing 163
4 gene 116.720907 116.805956 positive MGI_C57BL6J_2385204 Tesk2 NCBI_Gene:230661,ENSEMBL:ENSMUSG00000033985 MGI:2385204 protein coding gene testis-specific kinase 2
4 gene 116.725899 116.725989 positive MGI_C57BL6J_5531070 Gm27688 ENSEMBL:ENSMUSG00000098491 MGI:5531070 unclassified non-coding RNA gene predicted gene, 27688
4 gene 116.794310 116.807640 negative MGI_C57BL6J_1915526 Toe1 NCBI_Gene:68276,ENSEMBL:ENSMUSG00000028688 MGI:1915526 protein coding gene target of EGR1, member 1 (nuclear)
4 gene 116.807684 116.819440 positive MGI_C57BL6J_1917853 Mutyh NCBI_Gene:70603,ENSEMBL:ENSMUSG00000028687 MGI:1917853 protein coding gene mutY DNA glycosylase
4 gene 116.819904 116.821707 negative MGI_C57BL6J_2444646 Hpdl NCBI_Gene:242642,ENSEMBL:ENSMUSG00000043155 MGI:2444646 protein coding gene 4-hydroxyphenylpyruvate dioxygenase-like
4 gene 116.824263 116.830605 positive MGI_C57BL6J_3650481 Gm12996 NCBI_Gene:100502973,ENSEMBL:ENSMUSG00000086417 MGI:3650481 lncRNA gene predicted gene 12996
4 pseudogene 116.839880 116.840244 negative MGI_C57BL6J_3650480 Rpl36-ps8 NCBI_Gene:625336,ENSEMBL:ENSMUSG00000075390 MGI:3650480 pseudogene ribosomal protein L36, pseudogene 8
4 pseudogene 116.852664 116.853110 positive MGI_C57BL6J_3650479 Gm12994 ENSEMBL:ENSMUSG00000082841 MGI:3650479 pseudogene predicted gene 12994
4 pseudogene 116.874588 116.875465 negative MGI_C57BL6J_3650477 Gm12993 ENSEMBL:ENSMUSG00000082063 MGI:3650477 pseudogene predicted gene 12993
4 gene 116.877376 116.989264 positive MGI_C57BL6J_1921714 Zswim5 NCBI_Gene:74464,ENSEMBL:ENSMUSG00000033948 MGI:1921714 protein coding gene zinc finger SWIM-type containing 5
4 gene 116.904637 116.904741 positive MGI_C57BL6J_5456132 Gm26355 ENSEMBL:ENSMUSG00000088845 MGI:5456132 snRNA gene predicted gene, 26355
4 gene 116.915227 116.915493 positive MGI_C57BL6J_5455212 Gm25435 ENSEMBL:ENSMUSG00000088902 MGI:5455212 unclassified non-coding RNA gene predicted gene, 25435
4 gene 116.922384 116.922490 negative MGI_C57BL6J_5451869 Gm22092 ENSEMBL:ENSMUSG00000095805 MGI:5451869 snRNA gene predicted gene, 22092
4 pseudogene 116.945732 116.946534 negative MGI_C57BL6J_3651168 Gm12998 NCBI_Gene:100417429,ENSEMBL:ENSMUSG00000082207 MGI:3651168 pseudogene predicted gene 12998
4 gene 116.989965 116.994436 negative MGI_C57BL6J_98916 Urod NCBI_Gene:22275,ENSEMBL:ENSMUSG00000028684 MGI:98916 protein coding gene uroporphyrinogen decarboxylase
4 gene 116.995294 117.005277 positive MGI_C57BL6J_1923858 Hectd3 NCBI_Gene:76608,ENSEMBL:ENSMUSG00000046861 MGI:1923858 protein coding gene HECT domain E3 ubiquitin protein ligase 3
4 gene 117.002166 117.003012 negative MGI_C57BL6J_1919485 1700021J08Rik ENSEMBL:ENSMUSG00000086890 MGI:1919485 lncRNA gene RIKEN cDNA 1700021J08 gene
4 pseudogene 117.015127 117.015766 negative MGI_C57BL6J_3650026 Gm12997 NCBI_Gene:100416056,ENSEMBL:ENSMUSG00000082249 MGI:3650026 pseudogene predicted gene 12997
4 gene 117.019399 117.087306 positive MGI_C57BL6J_1313286 Eif2b3 NCBI_Gene:108067,ENSEMBL:ENSMUSG00000028683 MGI:1313286 protein coding gene eukaryotic translation initiation factor 2B, subunit 3
4 gene 117.027211 117.027309 positive MGI_C57BL6J_5452112 Gm22335 ENSEMBL:ENSMUSG00000088349 MGI:5452112 snRNA gene predicted gene, 22335
4 gene 117.095780 117.116101 positive MGI_C57BL6J_1095405 Ptch2 NCBI_Gene:19207,ENSEMBL:ENSMUSG00000028681 MGI:1095405 protein coding gene patched 2
4 gene 117.119218 117.125725 negative MGI_C57BL6J_1925861 Btbd19 NCBI_Gene:78611,ENSEMBL:ENSMUSG00000073771 MGI:1925861 protein coding gene BTB (POZ) domain containing 19
4 gene 117.124548 117.128738 positive MGI_C57BL6J_3045358 Tctex1d4 NCBI_Gene:242646,ENSEMBL:ENSMUSG00000047671 MGI:3045358 protein coding gene Tctex1 domain containing 4
4 gene 117.128655 117.133963 negative MGI_C57BL6J_109604 Plk3 NCBI_Gene:12795,ENSEMBL:ENSMUSG00000028680 MGI:109604 protein coding gene polo like kinase 3
4 pseudogene 117.145257 117.148637 positive MGI_C57BL6J_3663793 Best4-ps NCBI_Gene:230664,ENSEMBL:ENSMUSG00000033872 MGI:3663793 pseudogene bestrophin 4, pseudogene
4 pseudogene 117.148902 117.149303 positive MGI_C57BL6J_3651767 Gm13015 NCBI_Gene:625405,ENSEMBL:ENSMUSG00000070834 MGI:3651767 pseudogene predicted gene 13015
4 gene 117.153827 117.156243 negative MGI_C57BL6J_98166 Rps8 NCBI_Gene:20116,ENSEMBL:ENSMUSG00000047675 MGI:98166 protein coding gene ribosomal protein S8
4 gene 117.154093 117.154162 negative MGI_C57BL6J_5452757 Gm22980 ENSEMBL:ENSMUSG00000064542 MGI:5452757 snoRNA gene predicted gene, 22980
4 gene 117.154514 117.154584 negative MGI_C57BL6J_3819531 Snord38a NCBI_Gene:100217424,ENSEMBL:ENSMUSG00000065680 MGI:3819531 snoRNA gene small nucleolar RNA, C/D box 38A
4 gene 117.155186 117.155289 negative MGI_C57BL6J_5456107 Gm26330 ENSEMBL:ENSMUSG00000064751 MGI:5456107 snoRNA gene predicted gene, 26330
4 gene 117.155770 117.155848 negative MGI_C57BL6J_3819543 Snord55 NCBI_Gene:100216533,ENSEMBL:ENSMUSG00000092680 MGI:3819543 snoRNA gene small nucleolar RNA, C/D box 55
4 gene 117.158309 117.158433 negative MGI_C57BL6J_5452175 Gm22398 ENSEMBL:ENSMUSG00000095209 MGI:5452175 miRNA gene predicted gene, 22398
4 gene 117.159633 117.182639 negative MGI_C57BL6J_1921054 Kif2c NCBI_Gene:73804,ENSEMBL:ENSMUSG00000028678 MGI:1921054 protein coding gene kinesin family member 2C
4 gene 117.189942 117.190057 positive MGI_C57BL6J_5454876 Gm25099 ENSEMBL:ENSMUSG00000095676 MGI:5454876 snRNA gene predicted gene, 25099
4 gene 117.202528 117.202643 positive MGI_C57BL6J_5452920 Gm23143 ENSEMBL:ENSMUSG00000094405 MGI:5452920 snRNA gene predicted gene, 23143
4 gene 117.204989 117.205364 positive MGI_C57BL6J_3629729 Gt(pU21)107Imeg NA NA unclassified gene gene trap 107%2c Institute of Molecular Embryology and Genetics
4 gene 117.210844 117.210959 positive MGI_C57BL6J_5453064 Gm23287 ENSEMBL:ENSMUSG00000096280 MGI:5453064 snRNA gene predicted gene, 23287
4 gene 117.213326 117.252125 negative MGI_C57BL6J_2686507 Armh1 NCBI_Gene:381544,ENSEMBL:ENSMUSG00000060268 MGI:2686507 protein coding gene armadillo-like helical domain containing 1
4 gene 117.213334 117.213782 negative MGI_C57BL6J_1923635 1700012C08Rik ENSEMBL:ENSMUSG00000086482 MGI:1923635 lncRNA gene RIKEN cDNA 1700012C08 gene
4 gene 117.251951 117.268588 positive MGI_C57BL6J_1916027 Tmem53 NCBI_Gene:68777,ENSEMBL:ENSMUSG00000048772 MGI:1916027 protein coding gene transmembrane protein 53
4 gene 117.271463 117.497052 negative MGI_C57BL6J_1913993 Rnf220 NCBI_Gene:66743,ENSEMBL:ENSMUSG00000028677 MGI:1913993 protein coding gene ring finger protein 220
4 gene 117.289388 117.305424 positive MGI_C57BL6J_3651051 Gm12843 NCBI_Gene:102637763,ENSEMBL:ENSMUSG00000085749 MGI:3651051 lncRNA gene predicted gene 12843
4 gene 117.311744 117.319430 negative MGI_C57BL6J_5623116 Gm40231 NCBI_Gene:105244664 MGI:5623116 lncRNA gene predicted gene, 40231
4 gene 117.328088 117.329019 negative MGI_C57BL6J_1924582 C030012D19Rik NA NA unclassified gene RIKEN cDNA C030012D19 gene
4 gene 117.441726 117.455040 positive MGI_C57BL6J_3650145 Gm12828 NCBI_Gene:108168973,ENSEMBL:ENSMUSG00000086876 MGI:3650145 lncRNA gene predicted gene 12828
4 gene 117.495927 117.509315 positive MGI_C57BL6J_3651358 Gm12827 NCBI_Gene:102637578,ENSEMBL:ENSMUSG00000087228 MGI:3651358 lncRNA gene predicted gene 12827
4 gene 117.509361 117.519599 positive MGI_C57BL6J_5593828 Gm34669 NCBI_Gene:102637993 MGI:5593828 lncRNA gene predicted gene, 34669
4 pseudogene 117.513823 117.514201 negative MGI_C57BL6J_3650150 Gm12826 ENSEMBL:ENSMUSG00000083446 MGI:3650150 pseudogene predicted gene 12826
4 gene 117.550285 117.674297 positive MGI_C57BL6J_2153887 Eri3 NCBI_Gene:140546,ENSEMBL:ENSMUSG00000033423 MGI:2153887 protein coding gene exoribonuclease 3
4 gene 117.570134 117.570207 positive MGI_C57BL6J_5455336 Gm25559 ENSEMBL:ENSMUSG00000087807 MGI:5455336 miRNA gene predicted gene, 25559
4 pseudogene 117.598836 117.599393 positive MGI_C57BL6J_5011377 Gm19192 NCBI_Gene:100418411 MGI:5011377 pseudogene predicted gene, 19192
4 gene 117.674681 117.682321 negative MGI_C57BL6J_1913483 Dmap1 NCBI_Gene:66233,ENSEMBL:ENSMUSG00000009640 MGI:1913483 protein coding gene DNA methyltransferase 1-associated protein 1
4 gene 117.699075 117.704029 positive MGI_C57BL6J_5593905 Gm34746 NCBI_Gene:102638104 MGI:5593905 lncRNA gene predicted gene, 34746
4 gene 117.700188 117.700923 positive MGI_C57BL6J_3650917 Gm12840 ENSEMBL:ENSMUSG00000086320 MGI:3650917 lncRNA gene predicted gene 12840
4 gene 117.724412 117.726872 positive MGI_C57BL6J_3651666 Gm12845 NCBI_Gene:100416740,ENSEMBL:ENSMUSG00000108127 MGI:3651666 protein coding gene predicted gene 12845
4 pseudogene 117.728123 117.729599 negative MGI_C57BL6J_3651053 Gm12844 NCBI_Gene:433749,ENSEMBL:ENSMUSG00000084260 MGI:3651053 pseudogene predicted gene 12844
4 gene 117.756659 117.765666 negative MGI_C57BL6J_2181068 Klf17 NCBI_Gene:75753,ENSEMBL:ENSMUSG00000048626 MGI:2181068 protein coding gene Kruppel-like factor 17
4 gene 117.781698 117.787137 negative MGI_C57BL6J_5623117 Gm40232 NCBI_Gene:105244666 MGI:5623117 lncRNA gene predicted gene, 40232
4 pseudogene 117.824981 117.825694 negative MGI_C57BL6J_3651050 Gm12842 NCBI_Gene:606540,ENSEMBL:ENSMUSG00000083507 MGI:3651050 pseudogene predicted gene 12842
4 gene 117.834506 117.875198 positive MGI_C57BL6J_95760 Slc6a9 NCBI_Gene:14664,ENSEMBL:ENSMUSG00000028542 MGI:95760 protein coding gene solute carrier family 6 (neurotransmitter transporter, glycine), member 9
4 gene 117.835299 117.868558 negative MGI_C57BL6J_4937941 Gm17114 ENSEMBL:ENSMUSG00000091237 MGI:4937941 lncRNA gene predicted gene 17114
4 gene 117.866524 117.872661 negative MGI_C57BL6J_2685874 Ccdc24 NCBI_Gene:381546,ENSEMBL:ENSMUSG00000078588 MGI:2685874 protein coding gene coiled-coil domain containing 24
4 gene 117.869260 117.883487 negative MGI_C57BL6J_1858493 B4galt2 NCBI_Gene:53418,ENSEMBL:ENSMUSG00000028541 MGI:1858493 protein coding gene UDP-Gal:betaGlcNAc beta 1,4- galactosyltransferase, polypeptide 2
4 gene 117.874528 117.879336 positive MGI_C57BL6J_5623118 Gm40233 NCBI_Gene:105244667 MGI:5623118 lncRNA gene predicted gene, 40233
4 gene 117.883613 117.886184 positive MGI_C57BL6J_3651048 Gm12841 NCBI_Gene:108168974,ENSEMBL:ENSMUSG00000085278 MGI:3651048 lncRNA gene predicted gene 12841
4 gene 117.884326 117.887333 negative MGI_C57BL6J_1890510 Atp6v0b NCBI_Gene:114143,ENSEMBL:ENSMUSG00000033379 MGI:1890510 protein coding gene ATPase, H+ transporting, lysosomal V0 subunit B
4 gene 117.888643 117.892032 negative MGI_C57BL6J_1914978 Dph2 NCBI_Gene:67728,ENSEMBL:ENSMUSG00000028540 MGI:1914978 protein coding gene DPH2 homolog
4 gene 117.894486 117.915176 negative MGI_C57BL6J_2385205 Ipo13 NCBI_Gene:230673,ENSEMBL:ENSMUSG00000033365 MGI:2385205 protein coding gene importin 13
4 gene 117.925908 117.930795 negative MGI_C57BL6J_1333791 Artn NCBI_Gene:11876,ENSEMBL:ENSMUSG00000028539 MGI:1333791 protein coding gene artemin
4 gene 117.932152 118.134946 negative MGI_C57BL6J_1316659 St3gal3 NCBI_Gene:20441,ENSEMBL:ENSMUSG00000028538 MGI:1316659 protein coding gene ST3 beta-galactoside alpha-2,3-sialyltransferase 3
4 gene 117.972378 117.995297 positive MGI_C57BL6J_1925865 9530034E10Rik NCBI_Gene:78615,ENSEMBL:ENSMUSG00000086554 MGI:1925865 lncRNA gene RIKEN cDNA 9530034E10 gene
4 gene 118.136957 118.180043 negative MGI_C57BL6J_2446210 Kdm4a NCBI_Gene:230674,ENSEMBL:ENSMUSG00000033326 MGI:2446210 protein coding gene lysine (K)-specific demethylase 4A
4 gene 118.164078 118.164181 positive MGI_C57BL6J_5453159 Gm23382 ENSEMBL:ENSMUSG00000088303 MGI:5453159 snoRNA gene predicted gene, 23382
4 gene 118.208213 118.291405 negative MGI_C57BL6J_102695 Ptprf NCBI_Gene:19268,ENSEMBL:ENSMUSG00000033295 MGI:102695 protein coding gene protein tyrosine phosphatase, receptor type, F
4 gene 118.210505 118.210564 negative MGI_C57BL6J_5531012 Mir7226 miRBase:MI0023721,NCBI_Gene:102466820,ENSEMBL:ENSMUSG00000098596 MGI:5531012 miRNA gene microRNA 7226
4 gene 118.252250 118.257481 negative MGI_C57BL6J_5623120 Gm40235 NCBI_Gene:105244669 MGI:5623120 lncRNA gene predicted gene, 40235
4 pseudogene 118.359990 118.362744 positive MGI_C57BL6J_1915430 Hyi NCBI_Gene:68180,ENSEMBL:ENSMUSG00000006395 MGI:1915430 polymorphic pseudogene hydroxypyruvate isomerase (putative)
4 gene 118.362740 118.409273 negative MGI_C57BL6J_3033336 Szt2 NCBI_Gene:230676,ENSEMBL:ENSMUSG00000033253 MGI:3033336 protein coding gene SZT2 subunit of KICSTOR complex
4 gene 118.409298 118.415824 positive MGI_C57BL6J_1915269 Med8 NCBI_Gene:80509,ENSEMBL:ENSMUSG00000006392 MGI:1915269 protein coding gene mediator complex subunit 8
4 gene 118.428084 118.432953 positive MGI_C57BL6J_1858959 Elovl1 NCBI_Gene:54325,ENSEMBL:ENSMUSG00000006390 MGI:1858959 protein coding gene elongation of very long chain fatty acids (FEN1/Elo2, SUR4/Elo3, yeast)-like 1
4 gene 118.432901 118.437352 negative MGI_C57BL6J_1859866 Cdc20 NCBI_Gene:107995,ENSEMBL:ENSMUSG00000006398 MGI:1859866 protein coding gene cell division cycle 20
4 pseudogene 118.441013 118.441220 negative MGI_C57BL6J_3651259 Gm12858 ENSEMBL:ENSMUSG00000081921 MGI:3651259 pseudogene predicted gene 12858
4 gene 118.442412 118.457513 negative MGI_C57BL6J_97076 Mpl NCBI_Gene:17480,ENSEMBL:ENSMUSG00000006389 MGI:97076 protein coding gene myeloproliferative leukemia virus oncogene
4 gene 118.471191 118.490061 negative MGI_C57BL6J_99906 Tie1 NCBI_Gene:21846,ENSEMBL:ENSMUSG00000033191 MGI:99906 protein coding gene tyrosine kinase with immunoglobulin-like and EGF-like domains 1
4 pseudogene 118.490743 118.497642 negative MGI_C57BL6J_3651649 Gm12859 NCBI_Gene:545675,ENSEMBL:ENSMUSG00000080857 MGI:3651649 pseudogene predicted gene 12859
4 pseudogene 118.521976 118.522657 positive MGI_C57BL6J_3652230 Gm12857 NCBI_Gene:666596,ENSEMBL:ENSMUSG00000081233 MGI:3652230 pseudogene predicted gene 12857
4 gene 118.526997 118.530228 positive MGI_C57BL6J_1913701 2610528J11Rik NCBI_Gene:66451,ENSEMBL:ENSMUSG00000028536 MGI:1913701 protein coding gene RIKEN cDNA 2610528J11 gene
4 gene 118.540941 118.544954 negative MGI_C57BL6J_1923409 Tmem125 NCBI_Gene:230678,ENSEMBL:ENSMUSG00000050854 MGI:1923409 protein coding gene transmembrane protein 125
4 gene 118.547139 118.548256 positive MGI_C57BL6J_5623122 Gm40237 NCBI_Gene:105244671 MGI:5623122 lncRNA gene predicted gene, 40237
4 gene 118.554550 118.620777 negative MGI_C57BL6J_2686209 Cfap57 NCBI_Gene:68625,ENSEMBL:ENSMUSG00000028730 MGI:2686209 protein coding gene cilia and flagella associated protein 57
4 gene 118.620799 118.627776 positive MGI_C57BL6J_1916322 Ebna1bp2 NCBI_Gene:69072,ENSEMBL:ENSMUSG00000028729 MGI:1916322 protein coding gene EBNA1 binding protein 2
4 gene 118.626404 118.631915 positive MGI_C57BL6J_1277206 D4Ertd617e NCBI_Gene:100041290 MGI:1277206 lncRNA gene DNA segment, Chr 4, ERATO Doi 617, expressed
4 gene 118.630951 118.637832 negative MGI_C57BL6J_3650185 Gm12853 NCBI_Gene:102638941,ENSEMBL:ENSMUSG00000085292 MGI:3650185 lncRNA gene predicted gene 12853
4 gene 118.658952 118.668042 positive MGI_C57BL6J_1333887 Olfr62 NCBI_Gene:18363,ENSEMBL:ENSMUSG00000043698 MGI:1333887 protein coding gene olfactory receptor 62
4 pseudogene 118.672609 118.673522 negative MGI_C57BL6J_3031177 Olfr1343-ps1 NCBI_Gene:258707,ENSEMBL:ENSMUSG00000086521 MGI:3031177 pseudogene olfactory receptor 1343, pseudogene 1
4 gene 118.687486 118.693034 negative MGI_C57BL6J_3031176 Olfr1342 NCBI_Gene:258708,ENSEMBL:ENSMUSG00000043383 MGI:3031176 protein coding gene olfactory receptor 1342
4 gene 118.703523 118.713438 positive MGI_C57BL6J_3031175 Olfr1341 NCBI_Gene:258852,ENSEMBL:ENSMUSG00000046790 MGI:3031175 protein coding gene olfactory receptor 1341
4 gene 118.720138 118.729395 positive MGI_C57BL6J_3031174 Olfr1340 NCBI_Gene:258301,ENSEMBL:ENSMUSG00000070821 MGI:3031174 protein coding gene olfactory receptor 1340
4 pseudogene 118.722776 118.725477 negative MGI_C57BL6J_5439393 Gm21942 NCBI_Gene:257848 MGI:5439393 pseudogene predicted gene, 21942
4 gene 118.732175 118.736906 positive MGI_C57BL6J_3031173 Olfr1339 NCBI_Gene:258851,ENSEMBL:ENSMUSG00000070820 MGI:3031173 protein coding gene olfactory receptor 1339
4 gene 118.751975 118.758737 negative MGI_C57BL6J_3031172 Olfr1338 NCBI_Gene:258259,ENSEMBL:ENSMUSG00000095218 MGI:3031172 protein coding gene olfactory receptor 1338
4 gene 118.781636 118.782586 negative MGI_C57BL6J_3031171 Olfr1337 NCBI_Gene:258306,ENSEMBL:ENSMUSG00000111159 MGI:3031171 protein coding gene olfactory receptor 1337
4 pseudogene 118.791000 118.791907 negative MGI_C57BL6J_3649662 Gm12855 NCBI_Gene:257847,ENSEMBL:ENSMUSG00000081474 MGI:3649662 pseudogene predicted gene 12855
4 gene 118.808797 118.809944 negative MGI_C57BL6J_3031168 Olfr1335 NCBI_Gene:435804,ENSEMBL:ENSMUSG00000066061 MGI:3031168 protein coding gene olfactory receptor 1335
4 gene 118.827659 118.836279 negative MGI_C57BL6J_3031167 Olfr1333 NCBI_Gene:258265,ENSEMBL:ENSMUSG00000110947 MGI:3031167 protein coding gene olfactory receptor 1333
4 pseudogene 118.854086 118.855045 positive MGI_C57BL6J_3031166 Olfr1332-ps1 NCBI_Gene:257952,ENSEMBL:ENSMUSG00000083336 MGI:3031166 pseudogene olfactory receptor 1332, pseudogene 1
4 gene 118.864649 118.871707 positive MGI_C57BL6J_3031165 Olfr1331 NCBI_Gene:258159,ENSEMBL:ENSMUSG00000073769 MGI:3031165 protein coding gene olfactory receptor 1331
4 gene 118.888597 118.899597 positive MGI_C57BL6J_3031164 Olfr1330 NCBI_Gene:258331,ENSEMBL:ENSMUSG00000073768 MGI:3031164 protein coding gene olfactory receptor 1330
4 gene 118.897977 118.997411 negative MGI_C57BL6J_3651214 Gm12865 NCBI_Gene:105244672,ENSEMBL:ENSMUSG00000087238 MGI:3651214 lncRNA gene predicted gene 12865
4 gene 118.916524 118.917465 negative MGI_C57BL6J_3031163 Olfr1329 NCBI_Gene:258214,ENSEMBL:ENSMUSG00000096705 MGI:3031163 protein coding gene olfactory receptor 1329
4 gene 118.930071 118.938612 negative MGI_C57BL6J_3031162 Olfr1328 NCBI_Gene:258394,ENSEMBL:ENSMUSG00000111259 MGI:3031162 protein coding gene olfactory receptor 1328
4 pseudogene 118.942060 118.943352 negative MGI_C57BL6J_3649664 Gm12856 NCBI_Gene:100415963,ENSEMBL:ENSMUSG00000084133 MGI:3649664 pseudogene predicted gene 12856
4 gene 118.954273 118.954919 negative MGI_C57BL6J_3651212 Gm12863 NCBI_Gene:100038571,ENSEMBL:ENSMUSG00000073765 MGI:3651212 lncRNA gene predicted gene 12863
4 gene 118.961578 118.968912 positive MGI_C57BL6J_2140628 Lao1 NCBI_Gene:100470,ENSEMBL:ENSMUSG00000024903 MGI:2140628 protein coding gene L-amino acid oxidase 1
4 gene 118.971297 118.999458 positive MGI_C57BL6J_3651891 Gm12861 ENSEMBL:ENSMUSG00000085895 MGI:3651891 lncRNA gene predicted gene 12861
4 gene 118.980318 118.980442 positive MGI_C57BL6J_5454129 Gm24352 ENSEMBL:ENSMUSG00000089591 MGI:5454129 snoRNA gene predicted gene, 24352
4 pseudogene 118.986996 118.988226 positive MGI_C57BL6J_3649273 Gm12864 NCBI_Gene:666703,ENSEMBL:ENSMUSG00000082143 MGI:3649273 pseudogene predicted gene 12864
4 gene 118.999660 119.000485 negative MGI_C57BL6J_3651209 Gm12862 ENSEMBL:ENSMUSG00000087464 MGI:3651209 lncRNA gene predicted gene 12862
4 gene 119.050708 119.061964 positive MGI_C57BL6J_5428673 Lincred2 NCBI_Gene:100996932 MGI:5428673 lncRNA gene long intergenic non-protein coding RNA of erythroid differentiation 2
4 gene 119.054790 119.069111 negative MGI_C57BL6J_3649462 Gm12866 NCBI_Gene:433751,ENSEMBL:ENSMUSG00000066060 MGI:3649462 lncRNA gene predicted gene 12866
4 gene 119.073001 119.084352 positive MGI_C57BL6J_5594669 Gm35510 NCBI_Gene:102639122 MGI:5594669 lncRNA gene predicted gene, 35510
4 gene 119.108711 119.137983 positive MGI_C57BL6J_95755 Slc2a1 NCBI_Gene:20525,ENSEMBL:ENSMUSG00000028645 MGI:95755 protein coding gene solute carrier family 2 (facilitated glucose transporter), member 1
4 gene 119.129779 119.129844 positive MGI_C57BL6J_3837121 Mir1957a miRBase:MI0009954,ENSEMBL:ENSMUSG00000088552 MGI:3837121 miRNA gene microRNA 1957a
4 gene 119.130292 119.131001 negative MGI_C57BL6J_3651003 Gm12867 ENSEMBL:ENSMUSG00000086683 MGI:3651003 lncRNA gene predicted gene 12867
4 gene 119.133749 119.138801 negative MGI_C57BL6J_3651004 Gm12868 ENSEMBL:ENSMUSG00000085505 MGI:3651004 lncRNA gene predicted gene 12868
4 gene 119.169513 119.174195 negative MGI_C57BL6J_3041163 Zfp691 NCBI_Gene:195522,ENSEMBL:ENSMUSG00000045268 MGI:3041163 protein coding gene zinc finger protein 691
4 gene 119.175457 119.190017 negative MGI_C57BL6J_1349816 Ermap NCBI_Gene:27028,ENSEMBL:ENSMUSG00000028644 MGI:1349816 protein coding gene erythroblast membrane-associated protein
4 gene 119.195306 119.201298 positive MGI_C57BL6J_1916466 Svbp NCBI_Gene:69216,ENSEMBL:ENSMUSG00000028643 MGI:1916466 protein coding gene small vasohibin binding protein
4 gene 119.203570 119.232789 negative MGI_C57BL6J_2140466 AU022252 NCBI_Gene:230696,ENSEMBL:ENSMUSG00000078584 MGI:2140466 protein coding gene expressed sequence AU022252
4 gene 119.205012 119.218557 negative MGI_C57BL6J_1922430 Tmem269 NCBI_Gene:75180,ENSEMBL:ENSMUSG00000028642 MGI:1922430 protein coding gene transmembrane protein 269
4 gene 119.223174 119.224815 positive MGI_C57BL6J_3650325 Gm12898 ENSEMBL:ENSMUSG00000085626 MGI:3650325 lncRNA gene predicted gene 12898
4 gene 119.232892 119.248977 positive MGI_C57BL6J_1888921 P3h1 NCBI_Gene:56401,ENSEMBL:ENSMUSG00000028641 MGI:1888921 protein coding gene prolyl 3-hydroxylase 1
4 gene 119.252522 119.256975 negative MGI_C57BL6J_3651776 Gm12927 NCBI_Gene:102639193,ENSEMBL:ENSMUSG00000085203 MGI:3651776 lncRNA gene predicted gene 12927
4 gene 119.255414 119.262438 positive MGI_C57BL6J_3033992 Cldn19 NCBI_Gene:242653,ENSEMBL:ENSMUSG00000066058 MGI:3033992 protein coding gene claudin 19
4 gene 119.277327 119.294666 negative MGI_C57BL6J_99146 Ybx1 NCBI_Gene:22608,ENSEMBL:ENSMUSG00000028639 MGI:99146 protein coding gene Y box protein 1
4 gene 119.294137 119.295147 positive MGI_C57BL6J_1920791 1700102N10Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 1700102N10 gene
4 gene 119.295028 119.295461 negative MGI_C57BL6J_5611045 Gm37817 ENSEMBL:ENSMUSG00000102819 MGI:5611045 unclassified gene predicted gene, 37817
4 gene 119.300010 119.320546 negative MGI_C57BL6J_106499 Ppih NCBI_Gene:66101,ENSEMBL:ENSMUSG00000060288 MGI:106499 protein coding gene peptidyl prolyl isomerase H
4 gene 119.322466 119.415521 negative MGI_C57BL6J_1920582 Ccdc30 NCBI_Gene:73332,ENSEMBL:ENSMUSG00000028637 MGI:1920582 protein coding gene coiled-coil domain containing 30
4 pseudogene 119.333880 119.335542 negative MGI_C57BL6J_96761 Ldha-ps2 NCBI_Gene:16830,ENSEMBL:ENSMUSG00000083836 MGI:96761 pseudogene lactate dehydrogenase A, pseudogene 2
4 gene 119.393500 119.399924 positive MGI_C57BL6J_6324757 Gm50484 ENSEMBL:ENSMUSG00000118403 MGI:6324757 lncRNA gene predicted gene, 50484
4 gene 119.418527 119.422420 negative MGI_C57BL6J_1915237 Ppcs NCBI_Gene:106564,ENSEMBL:ENSMUSG00000028636 MGI:1915237 protein coding gene phosphopantothenoylcysteine synthetase
4 gene 119.422657 119.467444 positive MGI_C57BL6J_2140259 Zmynd12 NCBI_Gene:332934,ENSEMBL:ENSMUSG00000070806 MGI:2140259 protein coding gene zinc finger, MYND domain containing 12
4 gene 119.465283 119.492628 negative MGI_C57BL6J_3040686 Rimkla NCBI_Gene:194237,ENSEMBL:ENSMUSG00000048899 MGI:3040686 protein coding gene ribosomal modification protein rimK-like family member A
4 pseudogene 119.501865 119.502546 negative MGI_C57BL6J_3652229 Gm12954 ENSEMBL:ENSMUSG00000082009 MGI:3652229 pseudogene predicted gene 12954
4 pseudogene 119.509593 119.517728 negative MGI_C57BL6J_3652227 Gm12956 NCBI_Gene:102640085,ENSEMBL:ENSMUSG00000082814 MGI:3652227 pseudogene predicted gene 12956
4 pseudogene 119.519126 119.520082 negative MGI_C57BL6J_3652228 Gm12955 NCBI_Gene:666766,ENSEMBL:ENSMUSG00000080773 MGI:3652228 pseudogene predicted gene 12955
4 pseudogene 119.520863 119.521528 positive MGI_C57BL6J_3649304 Gm12957 NCBI_Gene:384052,ENSEMBL:ENSMUSG00000084379 MGI:3649304 pseudogene predicted gene 12957
4 pseudogene 119.527850 119.528169 positive MGI_C57BL6J_97991 Rnu6-ps2 NCBI_Gene:19864,ENSEMBL:ENSMUSG00000094494 MGI:97991 pseudogene U6 small nuclear RNA, pseudogene 2
4 gene 119.530308 119.539529 negative MGI_C57BL6J_3035485 Frg2f1 NCBI_Gene:433752,ENSEMBL:ENSMUSG00000087385 MGI:3035485 protein coding gene FSHD region gene 2 family member 1
4 gene 119.537004 119.629119 positive MGI_C57BL6J_2443432 Foxj3 NCBI_Gene:230700,ENSEMBL:ENSMUSG00000032998 MGI:2443432 protein coding gene forkhead box J3
4 pseudogene 119.553656 119.554058 negative MGI_C57BL6J_3649444 Gm12959 ENSEMBL:ENSMUSG00000081678 MGI:3649444 pseudogene predicted gene 12959
4 gene 119.637704 119.639471 positive MGI_C57BL6J_102738 Guca2a NCBI_Gene:14915,ENSEMBL:ENSMUSG00000023247 MGI:102738 protein coding gene guanylate cyclase activator 2a (guanylin)
4 gene 119.656601 119.658954 negative MGI_C57BL6J_1270851 Guca2b NCBI_Gene:14916,ENSEMBL:ENSMUSG00000032978 MGI:1270851 protein coding gene guanylate cyclase activator 2b (retina)
4 gene 119.658957 119.663760 positive MGI_C57BL6J_5594920 Gm35761 NCBI_Gene:102639449 MGI:5594920 lncRNA gene predicted gene, 35761
4 gene 119.695690 119.724141 negative MGI_C57BL6J_5595116 Gm35957 NCBI_Gene:102639707 MGI:5595116 lncRNA gene predicted gene, 35957
4 gene 119.733784 120.138045 positive MGI_C57BL6J_106589 Hivep3 NCBI_Gene:16656,ENSEMBL:ENSMUSG00000028634 MGI:106589 protein coding gene human immunodeficiency virus type I enhancer binding protein 3
4 gene 120.004621 120.049535 negative MGI_C57BL6J_5621517 Gm38632 NCBI_Gene:102642778 MGI:5621517 lncRNA gene predicted gene, 38632
4 gene 120.065760 120.074733 negative MGI_C57BL6J_5595374 Gm36215 NCBI_Gene:102640050 MGI:5595374 lncRNA gene predicted gene, 36215
4 gene 120.154185 120.262151 negative MGI_C57BL6J_5595293 Gm36134 NCBI_Gene:102639939 MGI:5595293 lncRNA gene predicted gene, 36134
4 gene 120.161206 120.167360 positive MGI_C57BL6J_95284 Edn2 NCBI_Gene:13615,ENSEMBL:ENSMUSG00000028635 MGI:95284 protein coding gene endothelin 2
4 gene 120.176181 120.181275 positive MGI_C57BL6J_5595232 Gm36073 NCBI_Gene:102639859 MGI:5595232 lncRNA gene predicted gene, 36073
4 gene 120.190783 120.200316 positive MGI_C57BL6J_5595172 Gm36013 NCBI_Gene:102639782 MGI:5595172 lncRNA gene predicted gene, 36013
4 gene 120.267078 120.287349 negative MGI_C57BL6J_2676586 Foxo6 NCBI_Gene:329934,ENSEMBL:ENSMUSG00000052135 MGI:2676586 protein coding gene forkhead box O6
4 gene 120.291134 120.303893 positive MGI_C57BL6J_3028036 Foxo6os NCBI_Gene:402730,ENSEMBL:ENSMUSG00000084929 MGI:3028036 antisense lncRNA gene forkhead box O6, opposite strand
4 gene 120.309702 120.312945 negative MGI_C57BL6J_5595658 Gm36499 NCBI_Gene:102640438 MGI:5595658 lncRNA gene predicted gene, 36499
4 gene 120.319102 120.397176 negative MGI_C57BL6J_5595733 Gm36574 NCBI_Gene:102640537 MGI:5595733 lncRNA gene predicted gene, 36574
4 gene 120.405281 120.530199 positive MGI_C57BL6J_1352762 Scmh1 NCBI_Gene:29871,ENSEMBL:ENSMUSG00000000085 MGI:1352762 protein coding gene sex comb on midleg homolog 1
4 gene 120.532107 120.536662 positive MGI_C57BL6J_3045330 Slfnl1 NCBI_Gene:194219,ENSEMBL:ENSMUSG00000047518 MGI:3045330 protein coding gene schlafen like 1
4 gene 120.539868 120.570276 negative MGI_C57BL6J_1858304 Ctps NCBI_Gene:51797,ENSEMBL:ENSMUSG00000028633 MGI:1858304 protein coding gene cytidine 5’-triphosphate synthase
4 gene 120.588745 120.609673 positive MGI_C57BL6J_3648581 Gm8439 NCBI_Gene:667063,ENSEMBL:ENSMUSG00000091297 MGI:3648581 protein coding gene predicted gene 8439
4 gene 120.615840 120.622682 positive MGI_C57BL6J_3651651 Gm12860 ENSEMBL:ENSMUSG00000086187 MGI:3651651 lncRNA gene predicted gene 12860
4 gene 120.644219 120.648137 negative MGI_C57BL6J_5791415 Gm45579 ENSEMBL:ENSMUSG00000110389 MGI:5791415 lncRNA gene predicted gene 45579
4 gene 120.659638 120.663276 positive MGI_C57BL6J_5589050 Gm29891 NCBI_Gene:102631594 MGI:5589050 lncRNA gene predicted gene, 29891
4 gene 120.666563 120.667820 positive MGI_C57BL6J_1861694 Cited4 NCBI_Gene:56222,ENSEMBL:ENSMUSG00000070803 MGI:1861694 protein coding gene Cbp/p300-interacting transactivator, with Glu/Asp-rich carboxy-terminal domain, 4
4 gene 120.696134 120.748612 negative MGI_C57BL6J_1926803 Kcnq4 NCBI_Gene:60613,ENSEMBL:ENSMUSG00000028631 MGI:1926803 protein coding gene potassium voltage-gated channel, subfamily Q, member 4
4 gene 120.757435 120.831579 negative MGI_C57BL6J_107901 Nfyc NCBI_Gene:18046,ENSEMBL:ENSMUSG00000032897 MGI:107901 protein coding gene nuclear transcription factor-Y gamma
4 gene 120.769534 120.769622 negative MGI_C57BL6J_2676909 Mir30c-1 miRBase:MI0000547,NCBI_Gene:387227,ENSEMBL:ENSMUSG00000065490 MGI:2676909 miRNA gene microRNA 30c-1
4 gene 120.772606 120.772697 positive MGI_C57BL6J_5562761 Mir30f miRBase:MI0021961,NCBI_Gene:102466650,ENSEMBL:ENSMUSG00000105585 MGI:5562761 miRNA gene microRNA 30f
4 gene 120.772606 120.772697 negative MGI_C57BL6J_3619329 Mir30e miRBase:MI0000259,NCBI_Gene:723836,ENSEMBL:ENSMUSG00000065409 MGI:3619329 miRNA gene microRNA 30e
4 gene 120.837488 120.837597 positive MGI_C57BL6J_5453713 Gm23936 ENSEMBL:ENSMUSG00000096876 MGI:5453713 miRNA gene predicted gene, 23936
4 gene 120.854779 120.896580 positive MGI_C57BL6J_2443331 Rims3 NCBI_Gene:242662,ENSEMBL:ENSMUSG00000032890 MGI:2443331 protein coding gene regulating synaptic membrane exocytosis 3
4 pseudogene 120.901113 120.902755 positive MGI_C57BL6J_3649219 Gm12871 NCBI_Gene:102631670,ENSEMBL:ENSMUSG00000082200 MGI:3649219 pseudogene predicted gene 12871
4 gene 120.903460 120.903563 positive MGI_C57BL6J_5454455 Gm24678 ENSEMBL:ENSMUSG00000089381 MGI:5454455 snRNA gene predicted gene, 24678
4 gene 120.921196 120.925017 negative MGI_C57BL6J_1920422 Exo5 NCBI_Gene:73172,ENSEMBL:ENSMUSG00000028629 MGI:1920422 protein coding gene exonuclease 5
4 gene 120.930133 120.953427 negative MGI_C57BL6J_107794 Zfp69 NCBI_Gene:381549,ENSEMBL:ENSMUSG00000064141 MGI:107794 protein coding gene zinc finger protein 69
4 gene 120.968317 121.017289 negative MGI_C57BL6J_1917030 Smap2 NCBI_Gene:69780,ENSEMBL:ENSMUSG00000032870 MGI:1917030 protein coding gene small ArfGAP 2
4 gene 120.973259 120.973322 negative MGI_C57BL6J_5562762 Mir7015 miRBase:MI0022864,NCBI_Gene:102465614,ENSEMBL:ENSMUSG00000106436 MGI:5562762 miRNA gene microRNA 7015
4 gene 121.039385 121.055325 positive MGI_C57BL6J_88466 Col9a2 NCBI_Gene:12840,ENSEMBL:ENSMUSG00000028626 MGI:88466 protein coding gene collagen, type IX, alpha 2
4 gene 121.059237 121.098249 negative MGI_C57BL6J_1890508 Zmpste24 NCBI_Gene:230709,ENSEMBL:ENSMUSG00000043207 MGI:1890508 protein coding gene zinc metallopeptidase, STE24
4 gene 121.075798 121.075922 negative MGI_C57BL6J_5455963 Gm26186 ENSEMBL:ENSMUSG00000088314 MGI:5455963 snoRNA gene predicted gene, 26186
4 gene 121.083986 121.084149 negative MGI_C57BL6J_5453317 Gm23540 ENSEMBL:ENSMUSG00000088168 MGI:5453317 snRNA gene predicted gene, 23540
4 gene 121.105651 121.109226 negative MGI_C57BL6J_1916719 Tmco2 NCBI_Gene:69469,ENSEMBL:ENSMUSG00000078577 MGI:1916719 protein coding gene transmembrane and coiled-coil domains 2
4 pseudogene 121.114770 121.115305 negative MGI_C57BL6J_3651897 Gm12882 NCBI_Gene:100042174,ENSEMBL:ENSMUSG00000081423 MGI:3651897 pseudogene predicted gene 12882
4 pseudogene 121.120874 121.130213 negative MGI_C57BL6J_3651892 Gm12881 NCBI_Gene:102640296,ENSEMBL:ENSMUSG00000082891 MGI:3651892 pseudogene predicted gene 12881
4 pseudogene 121.130118 121.131299 positive MGI_C57BL6J_3649632 Gm12879 ENSEMBL:ENSMUSG00000081305 MGI:3649632 pseudogene predicted gene 12879
4 gene 121.134657 121.134975 positive MGI_C57BL6J_5452759 Gm22982 ENSEMBL:ENSMUSG00000064547 MGI:5452759 unclassified non-coding RNA gene predicted gene, 22982
4 gene 121.145373 121.215118 negative MGI_C57BL6J_1924705 Rlf NCBI_Gene:109263,ENSEMBL:ENSMUSG00000049878 MGI:1924705 protein coding gene rearranged L-myc fusion sequence
4 pseudogene 121.227101 121.227473 negative MGI_C57BL6J_3652134 Gm12890 ENSEMBL:ENSMUSG00000080706 MGI:3652134 pseudogene predicted gene 12890
4 gene 121.230920 121.239213 positive MGI_C57BL6J_5589261 Gm30102 NCBI_Gene:102631880 MGI:5589261 lncRNA gene predicted gene, 30102
4 gene 121.235690 121.241508 negative MGI_C57BL6J_5623124 Gm40239 NCBI_Gene:105244675 MGI:5623124 lncRNA gene predicted gene, 40239
4 gene 121.316316 121.324917 negative MGI_C57BL6J_3652130 Gm12888 NCBI_Gene:545677,ENSEMBL:ENSMUSG00000073764 MGI:3652130 protein coding gene predicted gene 12888
4 pseudogene 121.379794 121.380034 positive MGI_C57BL6J_3652132 Gm12889 ENSEMBL:ENSMUSG00000083941 MGI:3652132 pseudogene predicted gene 12889
4 pseudogene 121.380595 121.380922 positive MGI_C57BL6J_3651896 Gm12885 ENSEMBL:ENSMUSG00000083901 MGI:3651896 pseudogene predicted gene 12885
4 pseudogene 121.381429 121.381753 positive MGI_C57BL6J_3651895 Gm12884 ENSEMBL:ENSMUSG00000081465 MGI:3651895 pseudogene predicted gene 12884
4 pseudogene 121.392992 121.396557 positive MGI_C57BL6J_3651898 Gm12883 ENSEMBL:ENSMUSG00000081667 MGI:3651898 pseudogene predicted gene 12883
4 gene 121.394203 121.396557 negative MGI_C57BL6J_3648197 Gm8359 NCBI_Gene:666914 MGI:3648197 protein coding gene predicted gene 8359
4 gene 121.414735 121.423099 negative MGI_C57BL6J_3651888 Gm12886 NCBI_Gene:666921,ENSEMBL:ENSMUSG00000078576 MGI:3651888 protein coding gene predicted gene 12886
4 pseudogene 121.476810 121.582789 negative MGI_C57BL6J_3651893 Gm12880 NCBI_Gene:100504652,ENSEMBL:ENSMUSG00000082821 MGI:3651893 pseudogene predicted gene 12880
4 gene 121.509472 121.509603 positive MGI_C57BL6J_5455939 Gm26162 ENSEMBL:ENSMUSG00000088418 MGI:5455939 snoRNA gene predicted gene, 26162
4 gene 121.614004 121.622125 negative MGI_C57BL6J_3652131 Gm12887 NCBI_Gene:666927,ENSEMBL:ENSMUSG00000078575 MGI:3652131 protein coding gene predicted gene 12887
4 pseudogene 121.641446 121.641777 positive MGI_C57BL6J_3649631 Gm12878 ENSEMBL:ENSMUSG00000083615 MGI:3649631 pseudogene predicted gene 12878
4 gene 121.907890 121.920833 negative MGI_C57BL6J_5434759 Gm21404 NCBI_Gene:100862019 MGI:5434759 protein coding gene predicted gene, 21404
4 pseudogene 122.008130 122.009562 positive MGI_C57BL6J_3649649 Gm12892 NCBI_Gene:666937,ENSEMBL:ENSMUSG00000083679 MGI:3649649 pseudogene predicted gene 12892
4 pseudogene 122.122847 122.123072 positive MGI_C57BL6J_3650312 Gm12896 ENSEMBL:ENSMUSG00000083558 MGI:3650312 pseudogene predicted gene 12896
4 pseudogene 122.187718 122.206721 positive MGI_C57BL6J_3649906 Gm12897 NCBI_Gene:102632107,ENSEMBL:ENSMUSG00000083949 MGI:3649906 pseudogene predicted gene 12897
4 pseudogene 122.234979 122.235917 positive MGI_C57BL6J_3652102 Gm12893 ENSEMBL:ENSMUSG00000083867 MGI:3652102 pseudogene predicted gene 12893
4 gene 122.300878 122.313819 negative MGI_C57BL6J_3649909 Gm10573 NCBI_Gene:666931 MGI:3649909 protein coding gene predicted gene 10573
4 pseudogene 122.455210 122.455435 positive MGI_C57BL6J_3649907 Gm12895 ENSEMBL:ENSMUSG00000083365 MGI:3649907 pseudogene predicted gene 12895
4 gene 122.520186 122.539153 positive MGI_C57BL6J_5589564 Gm30405 NCBI_Gene:102632293 MGI:5589564 lncRNA gene predicted gene, 30405
4 pseudogene 122.582700 122.604894 negative MGI_C57BL6J_3650567 Gm12877 ENSEMBL:ENSMUSG00000081377 MGI:3650567 pseudogene predicted gene 12877
4 pseudogene 122.592984 122.594068 positive MGI_C57BL6J_3651901 Gm12874 NCBI_Gene:100504420,ENSEMBL:ENSMUSG00000084196 MGI:3651901 pseudogene predicted gene 12874
4 pseudogene 122.640346 122.648326 negative MGI_C57BL6J_3649744 Gm12875 ENSEMBL:ENSMUSG00000080871 MGI:3649744 pseudogene predicted gene 12875
4 pseudogene 122.660923 122.677278 negative MGI_C57BL6J_3651904 Gm12876 ENSEMBL:ENSMUSG00000083109 MGI:3651904 pseudogene predicted gene 12876
4 gene 122.689259 122.705135 positive MGI_C57BL6J_1924682 9530002B09Rik NCBI_Gene:77432,ENSEMBL:ENSMUSG00000023263 MGI:1924682 protein coding gene RIKEN cDNA 9530002B09 gene
4 gene 122.726463 122.739532 negative MGI_C57BL6J_5589707 Gm30548 NCBI_Gene:102632489 MGI:5589707 lncRNA gene predicted gene, 30548
4 pseudogene 122.730284 122.734733 negative MGI_C57BL6J_3649389 Gm12872 ENSEMBL:ENSMUSG00000084082 MGI:3649389 pseudogene predicted gene 12872
4 pseudogene 122.771483 122.793803 negative MGI_C57BL6J_3651900 Gm12873 NCBI_Gene:102632555,ENSEMBL:ENSMUSG00000083494 MGI:3651900 pseudogene predicted gene 12873
4 gene 122.836073 122.859175 positive MGI_C57BL6J_1298204 Ppt1 NCBI_Gene:19063,ENSEMBL:ENSMUSG00000028657 MGI:1298204 protein coding gene palmitoyl-protein thioesterase 1
4 gene 122.859047 122.886071 negative MGI_C57BL6J_88262 Cap1 NCBI_Gene:12331,ENSEMBL:ENSMUSG00000028656 MGI:88262 protein coding gene CAP, adenylate cyclase-associated protein 1 (yeast)
4 pseudogene 122.925818 122.926161 positive MGI_C57BL6J_3649646 Gm12891 NCBI_Gene:102632907,ENSEMBL:ENSMUSG00000080929 MGI:3649646 pseudogene predicted gene 12891
4 gene 122.946850 122.961195 negative MGI_C57BL6J_1923824 Mfsd2a NCBI_Gene:76574,ENSEMBL:ENSMUSG00000028655 MGI:1923824 protein coding gene major facilitator superfamily domain containing 2A
4 gene 122.961309 122.963475 positive MGI_C57BL6J_1918347 4933421A08Rik ENSEMBL:ENSMUSG00000086443 MGI:1918347 lncRNA gene RIKEN cDNA 4933421A08 gene
4 gene 122.995609 123.002490 positive MGI_C57BL6J_96799 Mycl NCBI_Gene:16918,ENSEMBL:ENSMUSG00000028654 MGI:96799 protein coding gene v-myc avian myelocytomatosis viral oncogene lung carcinoma derived
4 gene 123.016532 123.054949 positive MGI_C57BL6J_1914216 Trit1 NCBI_Gene:66966,ENSEMBL:ENSMUSG00000028653 MGI:1914216 protein coding gene tRNA isopentenyltransferase 1
4 gene 123.081151 123.089356 positive MGI_C57BL6J_5826505 Gm46868 NCBI_Gene:108168975 MGI:5826505 lncRNA gene predicted gene, 46868
4 gene 123.081209 123.094028 negative MGI_C57BL6J_3651539 Gm12923 NCBI_Gene:105244676,ENSEMBL:ENSMUSG00000086153 MGI:3651539 lncRNA gene predicted gene 12923
4 gene 123.104307 123.132099 positive MGI_C57BL6J_107335 Bmp8b NCBI_Gene:12164,ENSEMBL:ENSMUSG00000002384 MGI:107335 protein coding gene bone morphogenetic protein 8b
4 gene 123.113349 123.116764 negative MGI_C57BL6J_4936878 Gm17244 ENSEMBL:ENSMUSG00000102997 MGI:4936878 unclassified gene predicted gene, 17244
4 gene 123.116248 123.118000 positive MGI_C57BL6J_2664115 Oxct2b NCBI_Gene:353371,ENSEMBL:ENSMUSG00000076438 MGI:2664115 protein coding gene 3-oxoacid CoA transferase 2B
4 gene 123.127114 123.140001 negative MGI_C57BL6J_1917118 Ppie NCBI_Gene:56031,ENSEMBL:ENSMUSG00000028651 MGI:1917118 protein coding gene peptidylprolyl isomerase E (cyclophilin E)
4 gene 123.183227 123.194701 positive MGI_C57BL6J_2157521 Hpcal4 NCBI_Gene:170638,ENSEMBL:ENSMUSG00000046093 MGI:2157521 protein coding gene hippocalcin-like 4
4 gene 123.201204 123.225339 positive MGI_C57BL6J_2155700 Nt5c1a NCBI_Gene:230718,ENSEMBL:ENSMUSG00000054958 MGI:2155700 protein coding gene 5’-nucleotidase, cytosolic IA
4 gene 123.233556 123.249875 positive MGI_C57BL6J_1860511 Heyl NCBI_Gene:56198,ENSEMBL:ENSMUSG00000032744 MGI:1860511 protein coding gene hairy/enhancer-of-split related with YRPW motif-like
4 pseudogene 123.258046 123.258904 positive MGI_C57BL6J_3650176 Gm12901 NCBI_Gene:194197,ENSEMBL:ENSMUSG00000083720 MGI:3650176 pseudogene predicted gene 12901
4 gene 123.262351 123.298925 positive MGI_C57BL6J_2385206 Pabpc4 NCBI_Gene:230721,ENSEMBL:ENSMUSG00000011257 MGI:2385206 protein coding gene poly(A) binding protein, cytoplasmic 4
4 pseudogene 123.274874 123.275546 negative MGI_C57BL6J_3650387 Gm12900 NCBI_Gene:622334,ENSEMBL:ENSMUSG00000082634 MGI:3650387 pseudogene predicted gene 12900
4 gene 123.291344 123.291474 positive MGI_C57BL6J_5455565 Gm25788 ENSEMBL:ENSMUSG00000064655 MGI:5455565 snoRNA gene predicted gene, 25788
4 gene 123.293152 123.293282 positive MGI_C57BL6J_5451931 Gm22154 ENSEMBL:ENSMUSG00000065778 MGI:5451931 snoRNA gene predicted gene, 22154
4 gene 123.312645 123.343252 negative MGI_C57BL6J_104515 Bmp8a NCBI_Gene:12163,ENSEMBL:ENSMUSG00000032726 MGI:104515 protein coding gene bone morphogenetic protein 8a
4 gene 123.321875 123.323679 negative MGI_C57BL6J_1891061 Oxct2a NCBI_Gene:64059,ENSEMBL:ENSMUSG00000076436 MGI:1891061 protein coding gene 3-oxoacid CoA transferase 2A
4 gene 123.349633 123.684360 negative MGI_C57BL6J_108559 Macf1 NCBI_Gene:11426,ENSEMBL:ENSMUSG00000028649 MGI:108559 protein coding gene microtubule-actin crosslinking factor 1
4 gene 123.403601 123.411911 negative MGI_C57BL6J_3045367 D830031N03Rik NCBI_Gene:442834 MGI:3045367 protein coding gene RIKEN cDNA D830031N03 gene
4 pseudogene 123.435205 123.436380 positive MGI_C57BL6J_3651538 Gm12924 NCBI_Gene:102633376,ENSEMBL:ENSMUSG00000081528 MGI:3651538 pseudogene predicted gene 12924
4 gene 123.490231 123.490336 positive MGI_C57BL6J_5453325 Gm23548 ENSEMBL:ENSMUSG00000089588 MGI:5453325 unclassified non-coding RNA gene predicted gene, 23548
4 gene 123.550407 123.557041 positive MGI_C57BL6J_5590315 Gm31156 NCBI_Gene:102633296 MGI:5590315 lncRNA gene predicted gene, 31156
4 gene 123.616420 123.616521 positive MGI_C57BL6J_5531039 Mir6398 miRBase:MI0021934,NCBI_Gene:102465214,ENSEMBL:ENSMUSG00000099005 MGI:5531039 miRNA gene microRNA 6398
4 pseudogene 123.630295 123.630703 positive MGI_C57BL6J_3651535 Gm12926 ENSEMBL:ENSMUSG00000081585 MGI:3651535 pseudogene predicted gene 12926
4 pseudogene 123.644650 123.647879 negative MGI_C57BL6J_5594400 Gm35241 NCBI_Gene:102638752 MGI:5594400 pseudogene predicted gene, 35241
4 gene 123.665881 123.671217 positive MGI_C57BL6J_3651536 Gm12925 NCBI_Gene:102633214,ENSEMBL:ENSMUSG00000087307 MGI:3651536 lncRNA gene predicted gene 12925
4 pseudogene 123.709181 123.710051 negative MGI_C57BL6J_3651537 Gm12922 NCBI_Gene:100039110,ENSEMBL:ENSMUSG00000081170 MGI:3651537 pseudogene predicted gene 12922
4 gene 123.712710 123.718202 negative MGI_C57BL6J_1890889 Ndufs5 NCBI_Gene:595136,ENSEMBL:ENSMUSG00000028648 MGI:1890889 protein coding gene NADH:ubiquinone oxidoreductase core subunit S5
4 gene 123.734559 123.750345 negative MGI_C57BL6J_1915300 Akirin1 NCBI_Gene:68050,ENSEMBL:ENSMUSG00000023075 MGI:1915300 protein coding gene akirin 1
4 gene 123.787874 123.830201 positive MGI_C57BL6J_3608413 Rhbdl2 NCBI_Gene:230726,ENSEMBL:ENSMUSG00000043333 MGI:3608413 protein coding gene rhomboid like 2
4 gene 123.833622 123.859513 negative MGI_C57BL6J_1925891 1700121C08Rik NCBI_Gene:105244677,ENSEMBL:ENSMUSG00000086275 MGI:1925891 lncRNA gene RIKEN cDNA 1700121C08 gene
4 pseudogene 123.838098 123.839502 positive MGI_C57BL6J_3650403 Gm12904 NCBI_Gene:667064,ENSEMBL:ENSMUSG00000082310 MGI:3650403 pseudogene predicted gene 12904
4 pseudogene 123.845999 123.849513 negative MGI_C57BL6J_5826497 Gm46860 NCBI_Gene:108168958 MGI:5826497 pseudogene predicted gene, 46860
4 gene 123.859679 123.863165 positive MGI_C57BL6J_3613760 4933427I04Rik ENSEMBL:ENSMUSG00000073761 MGI:3613760 protein coding gene Riken cDNA 4933427I04 gene
4 gene 123.877164 123.880582 positive MGI_C57BL6J_5590468 Gm31309 NCBI_Gene:102633498 MGI:5590468 protein coding gene predicted gene, 31309
4 gene 123.895294 123.896568 negative MGI_C57BL6J_3642540 Gm10572 NA NA unclassified gene predicted gene 10572
4 gene 123.897862 123.901214 negative MGI_C57BL6J_5623125 Gm40240 NCBI_Gene:105244678 MGI:5623125 lncRNA gene predicted gene, 40240
4 gene 123.898633 123.904842 negative MGI_C57BL6J_5477100 Gm26606 ENSEMBL:ENSMUSG00000097337 MGI:5477100 lncRNA gene predicted gene, 26606
4 pseudogene 123.902074 123.905046 negative MGI_C57BL6J_3045257 D130007C19Rik NCBI_Gene:442805,ENSEMBL:ENSMUSG00000054304 MGI:3045257 pseudogene RIKEN cDNA D130007C19 gene
4 pseudogene 123.902422 123.902965 positive MGI_C57BL6J_3650402 Gm12903 ENSEMBL:ENSMUSG00000080993 MGI:3650402 pseudogene predicted gene 12903
4 gene 123.904832 123.912269 positive MGI_C57BL6J_1891750 Mycbp NCBI_Gene:56309,ENSEMBL:ENSMUSG00000028647 MGI:1891750 protein coding gene MYC binding protein
4 gene 123.905062 123.918023 negative MGI_C57BL6J_3702581 Gm12905 ENSEMBL:ENSMUSG00000085875 MGI:3702581 lncRNA gene predicted gene 12905
4 gene 123.915318 123.918023 negative MGI_C57BL6J_1922470 4930535I16Rik NA NA protein coding gene RIKEN cDNA 4930535I16 gene
4 gene 123.917433 123.936997 positive MGI_C57BL6J_1858751 Rragc NCBI_Gene:54170,ENSEMBL:ENSMUSG00000028646 MGI:1858751 protein coding gene Ras-related GTP binding C
4 pseudogene 123.926234 123.926555 positive MGI_C57BL6J_3650399 Gm12902 ENSEMBL:ENSMUSG00000082515 MGI:3650399 pseudogene predicted gene 12902
4 gene 124.053958 124.070115 positive MGI_C57BL6J_5623126 Gm40241 NCBI_Gene:105244679 MGI:5623126 lncRNA gene predicted gene, 40241
4 gene 124.271428 124.272407 negative MGI_C57BL6J_5623127 Gm40242 NCBI_Gene:105244680 MGI:5623127 lncRNA gene predicted gene, 40242
4 gene 124.277777 124.279177 negative MGI_C57BL6J_5610895 Gm37667 ENSEMBL:ENSMUSG00000103541 MGI:5610895 unclassified gene predicted gene, 37667
4 gene 124.293101 124.299923 negative MGI_C57BL6J_3649992 Gm12916 NCBI_Gene:102633918,ENSEMBL:ENSMUSG00000086087 MGI:3649992 lncRNA gene predicted gene 12916
4 gene 124.302837 124.332720 negative MGI_C57BL6J_1923660 1700021L23Rik NCBI_Gene:76410,ENSEMBL:ENSMUSG00000086955 MGI:1923660 lncRNA gene RIKEN cDNA 1700021L23 gene
4 gene 124.326308 124.332508 negative MGI_C57BL6J_1918570 4933435F18Rik ENSEMBL:ENSMUSG00000086978 MGI:1918570 lncRNA gene RIKEN cDNA 4933435F18 gene
4 gene 124.335578 124.335681 negative MGI_C57BL6J_5452760 Gm22983 ENSEMBL:ENSMUSG00000088933 MGI:5452760 snRNA gene predicted gene, 22983
4 gene 124.414416 124.485959 negative MGI_C57BL6J_1925710 1700057H15Rik NCBI_Gene:78460,ENSEMBL:ENSMUSG00000084757 MGI:1925710 lncRNA gene RIKEN cDNA 1700057H15 gene
4 gene 124.451447 124.456444 positive MGI_C57BL6J_5590989 Gm31830 NCBI_Gene:102634185 MGI:5590989 lncRNA gene predicted gene, 31830
4 gene 124.465276 124.468075 negative MGI_C57BL6J_5590928 Gm31769 NCBI_Gene:102634107 MGI:5590928 lncRNA gene predicted gene, 31769
4 gene 124.522925 124.657504 negative MGI_C57BL6J_3780334 Gm2164 NCBI_Gene:100039332,ENSEMBL:ENSMUSG00000098760 MGI:3780334 lncRNA gene predicted gene 2164
4 gene 124.569179 124.575538 positive MGI_C57BL6J_1918352 4933407E24Rik NCBI_Gene:108809,ENSEMBL:ENSMUSG00000073759 MGI:1918352 lncRNA gene RIKEN cDNA 4933407E24 gene
4 gene 124.609931 124.610803 negative MGI_C57BL6J_1917499 3100002H09Rik NA NA lncRNA gene RIKEN cDNA 3100002H09 gene
4 gene 124.639918 124.640837 positive MGI_C57BL6J_1915732 1110007E10Rik NA NA unclassified gene RIKEN cDNA 1110007E10 gene
4 gene 124.656807 124.660655 positive MGI_C57BL6J_101896 Pou3f1 NCBI_Gene:18991,ENSEMBL:ENSMUSG00000090125 MGI:101896 protein coding gene POU domain, class 3, transcription factor 1
4 gene 124.664294 124.668677 negative MGI_C57BL6J_5621430 Gm38545 NCBI_Gene:102641270 MGI:5621430 lncRNA gene predicted gene, 38545
4 gene 124.678160 124.693612 negative MGI_C57BL6J_1914455 Utp11 NCBI_Gene:67205,ENSEMBL:ENSMUSG00000028907 MGI:1914455 protein coding gene UTP11 small subunit processome component
4 gene 124.695965 124.708611 positive MGI_C57BL6J_1341092 Fhl3 NCBI_Gene:14201,ENSEMBL:ENSMUSG00000032643 MGI:1341092 protein coding gene four and a half LIM domains 3
4 gene 124.697505 124.697607 negative MGI_C57BL6J_5454257 Gm24480 ENSEMBL:ENSMUSG00000088067 MGI:5454257 snRNA gene predicted gene, 24480
4 gene 124.714776 124.732460 positive MGI_C57BL6J_1922312 Sf3a3 NCBI_Gene:75062,ENSEMBL:ENSMUSG00000028902 MGI:1922312 protein coding gene splicing factor 3a, subunit 3
4 pseudogene 124.718999 124.719637 positive MGI_C57BL6J_3652006 Gm12917 NCBI_Gene:664991,ENSEMBL:ENSMUSG00000083104 MGI:3652006 pseudogene predicted gene 12917
4 gene 124.731694 124.731802 positive MGI_C57BL6J_3629652 Mir697 miRBase:MI0004681,NCBI_Gene:735277,ENSEMBL:ENSMUSG00000076271 MGI:3629652 miRNA gene microRNA 697
4 gene 124.735267 124.751354 negative MGI_C57BL6J_3650273 Gm12915 NCBI_Gene:102634646,ENSEMBL:ENSMUSG00000086589 MGI:3650273 lncRNA gene predicted gene 12915
4 gene 124.735839 124.735948 positive MGI_C57BL6J_5454498 Gm24721 ENSEMBL:ENSMUSG00000096411 MGI:5454498 miRNA gene predicted gene, 24721
4 gene 124.737406 124.740105 positive MGI_C57BL6J_5591276 Gm32117 NCBI_Gene:102634569 MGI:5591276 lncRNA gene predicted gene, 32117
4 gene 124.741827 124.801511 positive MGI_C57BL6J_103257 Inpp5b NCBI_Gene:16330,ENSEMBL:ENSMUSG00000028894 MGI:103257 protein coding gene inositol polyphosphate-5-phosphatase B
4 gene 124.743781 124.743889 positive MGI_C57BL6J_3629653 Mir698 miRBase:MI0004682,NCBI_Gene:735263,ENSEMBL:ENSMUSG00000076119 MGI:3629653 miRNA gene microRNA 698
4 gene 124.802104 124.849800 positive MGI_C57BL6J_101786 Mtf1 NCBI_Gene:17764,ENSEMBL:ENSMUSG00000028890 MGI:101786 protein coding gene metal response element binding transcription factor 1
4 gene 124.820821 124.820939 positive MGI_C57BL6J_4422057 n-R5s192 ENSEMBL:ENSMUSG00000084526 MGI:4422057 rRNA gene nuclear encoded rRNA 5S 192
4 gene 124.849080 124.851196 negative MGI_C57BL6J_1916170 1110065P20Rik NCBI_Gene:68920,ENSEMBL:ENSMUSG00000078570 MGI:1916170 protein coding gene RIKEN cDNA 1110065P20 gene
4 gene 124.850679 124.855242 positive MGI_C57BL6J_2387201 Yrdc NCBI_Gene:230734,ENSEMBL:ENSMUSG00000028889 MGI:2387201 protein coding gene yrdC domain containing (E.coli)
4 gene 124.855239 124.880938 negative MGI_C57BL6J_2684896 Maneal NCBI_Gene:215090,ENSEMBL:ENSMUSG00000042763 MGI:2684896 protein coding gene mannosidase, endo-alpha-like
4 gene 124.880899 124.917800 positive MGI_C57BL6J_3586824 Epha10 NCBI_Gene:230735,ENSEMBL:ENSMUSG00000028876 MGI:3586824 protein coding gene Eph receptor A10
4 gene 124.890888 124.894782 negative MGI_C57BL6J_1920878 1700125G02Rik NCBI_Gene:73628,ENSEMBL:ENSMUSG00000085263 MGI:1920878 lncRNA gene RIKEN cDNA 1700125G02 gene
4 gene 124.918465 124.939311 negative MGI_C57BL6J_1196274 Cdca8 NCBI_Gene:52276,ENSEMBL:ENSMUSG00000028873 MGI:1196274 protein coding gene cell division cycle associated 8
4 gene 124.936987 124.944661 positive MGI_C57BL6J_3041172 9930104L06Rik NCBI_Gene:194268,ENSEMBL:ENSMUSG00000044730 MGI:3041172 protein coding gene RIKEN cDNA 9930104L06 gene
4 gene 124.945664 124.962828 positive MGI_C57BL6J_5623128 Gm40243 NCBI_Gene:105244681 MGI:5623128 lncRNA gene predicted gene, 40243
4 gene 124.957647 124.987009 negative MGI_C57BL6J_3650529 Gm12930 ENSEMBL:ENSMUSG00000087011 MGI:3650529 lncRNA gene predicted gene 12930
4 gene 124.967638 124.974608 negative MGI_C57BL6J_5591530 Gm32371 NCBI_Gene:102634896 MGI:5591530 lncRNA gene predicted gene, 32371
4 gene 124.986397 125.009102 positive MGI_C57BL6J_2183426 Rspo1 NCBI_Gene:192199,ENSEMBL:ENSMUSG00000028871 MGI:2183426 protein coding gene R-spondin 1
4 gene 125.016585 125.055382 positive MGI_C57BL6J_2385207 Gnl2 NCBI_Gene:230737,ENSEMBL:ENSMUSG00000028869 MGI:2385207 protein coding gene guanine nucleotide binding protein-like 2 (nucleolar)
4 gene 125.017675 125.021008 positive MGI_C57BL6J_5621357 Gm38472 NCBI_Gene:102635036 MGI:5621357 lncRNA gene predicted gene, 38472
4 pseudogene 125.019500 125.019823 positive MGI_C57BL6J_3650713 Gm12931 ENSEMBL:ENSMUSG00000080934 MGI:3650713 pseudogene predicted gene 12931
4 gene 125.055338 125.065703 negative MGI_C57BL6J_1922813 Dnali1 NCBI_Gene:75563,ENSEMBL:ENSMUSG00000042707 MGI:1922813 protein coding gene dynein, axonemal, light intermediate polypeptide 1
4 gene 125.066672 125.074054 positive MGI_C57BL6J_2156003 Snip1 NCBI_Gene:76793,ENSEMBL:ENSMUSG00000050213 MGI:2156003 protein coding gene Smad nuclear interacting protein 1
4 pseudogene 125.075509 125.076480 positive MGI_C57BL6J_5010665 Gm18480 NCBI_Gene:100417248 MGI:5010665 pseudogene predicted gene, 18480
4 gene 125.082857 125.084947 negative MGI_C57BL6J_3651151 Gm12932 ENSEMBL:ENSMUSG00000086342 MGI:3651151 lncRNA gene predicted gene 12932
4 gene 125.085132 125.113238 positive MGI_C57BL6J_1917338 Meaf6 NCBI_Gene:70088,ENSEMBL:ENSMUSG00000028863 MGI:1917338 protein coding gene MYST/Esa1-associated factor 6
4 gene 125.118414 125.127881 negative MGI_C57BL6J_2385891 Zc3h12a NCBI_Gene:230738,ENSEMBL:ENSMUSG00000042677 MGI:2385891 protein coding gene zinc finger CCCH type containing 12A
4 gene 125.137545 125.147719 negative MGI_C57BL6J_5623131 Gm40246 NCBI_Gene:105244684 MGI:5623131 lncRNA gene predicted gene, 40246
4 gene 125.145206 125.290415 positive MGI_C57BL6J_5591770 Gm32611 NCBI_Gene:102635216 MGI:5591770 protein coding gene predicted gene, 32611
4 gene 125.150043 125.187052 positive MGI_C57BL6J_5623130 Gm40245 NCBI_Gene:105244683 MGI:5623130 lncRNA gene predicted gene, 40245
4 gene 125.218444 125.219892 positive MGI_C57BL6J_5623129 Gm40244 NCBI_Gene:105244682 MGI:5623129 lncRNA gene predicted gene, 40244
4 gene 125.228597 125.242052 positive MGI_C57BL6J_1920510 1700041M05Rik ENSEMBL:ENSMUSG00000087010 MGI:1920510 lncRNA gene RIKEN cDNA 1700041M05 gene
4 gene 125.290536 125.301544 positive MGI_C57BL6J_5826506 Gm46869 NCBI_Gene:108168977 MGI:5826506 lncRNA gene predicted gene, 46869
4 gene 125.312310 125.313514 negative MGI_C57BL6J_5591855 Gm32696 NCBI_Gene:102635326 MGI:5591855 lncRNA gene predicted gene, 32696
4 gene 125.381681 125.394495 positive MGI_C57BL6J_5623132 Gm40247 NCBI_Gene:105244685 MGI:5623132 lncRNA gene predicted gene, 40247
4 gene 125.451074 125.477201 positive MGI_C57BL6J_5591915 Gm32756 NCBI_Gene:102635406 MGI:5591915 lncRNA gene predicted gene, 32756
4 gene 125.490206 125.714173 positive MGI_C57BL6J_95816 Grik3 NCBI_Gene:14807,ENSEMBL:ENSMUSG00000001985 MGI:95816 protein coding gene glutamate receptor, ionotropic, kainate 3
4 pseudogene 125.504080 125.505018 positive MGI_C57BL6J_95590 Ftl2-ps NCBI_Gene:14337,ENSEMBL:ENSMUSG00000082062 MGI:95590 pseudogene ferritin light polypeptide 2, pseudogene
4 gene 125.504749 125.504857 positive MGI_C57BL6J_3629654 Mir692-2 NCBI_Gene:735288,ENSEMBL:ENSMUSG00000094403 MGI:3629654 miRNA gene microRNA 692-2
4 gene 125.550236 125.556079 negative MGI_C57BL6J_5591966 Gm32807 NCBI_Gene:102635479 MGI:5591966 lncRNA gene predicted gene, 32807
4 gene 125.829719 125.836808 negative MGI_C57BL6J_5623134 Gm40249 NCBI_Gene:105244687 MGI:5623134 lncRNA gene predicted gene, 40249
4 gene 125.887851 125.922417 negative MGI_C57BL6J_1919645 2610028E06Rik NCBI_Gene:72395,ENSEMBL:ENSMUSG00000085562 MGI:1919645 lncRNA gene RIKEN cDNA 2610028E06 gene
4 gene 126.011163 126.024517 negative MGI_C57BL6J_5592067 Gm32908 NCBI_Gene:102635619 MGI:5592067 lncRNA gene predicted gene, 32908
4 gene 126.023441 126.044975 positive MGI_C57BL6J_1339755 Csf3r NCBI_Gene:12986,ENSEMBL:ENSMUSG00000028859 MGI:1339755 protein coding gene colony stimulating factor 3 receptor (granulocyte)
4 gene 126.046925 126.055536 positive MGI_C57BL6J_1913657 Mrps15 NCBI_Gene:66407,ENSEMBL:ENSMUSG00000028861 MGI:1913657 protein coding gene mitochondrial ribosomal protein S15
4 gene 126.055982 126.092195 positive MGI_C57BL6J_1916308 Oscp1 NCBI_Gene:230751,ENSEMBL:ENSMUSG00000042616 MGI:1916308 protein coding gene organic solute carrier partner 1
4 pseudogene 126.069827 126.070316 negative MGI_C57BL6J_3650282 Rpl28-ps3 NCBI_Gene:100039645,ENSEMBL:ENSMUSG00000079942 MGI:3650282 pseudogene ribosomal protein L28, pseudogene 3
4 gene 126.096577 126.098584 positive MGI_C57BL6J_2151045 Lsm10 NCBI_Gene:116748,ENSEMBL:ENSMUSG00000050188 MGI:2151045 protein coding gene U7 snRNP-specific Sm-like protein LSM10
4 gene 126.100491 126.104659 negative MGI_C57BL6J_1924911 1520401O13Rik NA NA unclassified gene RIKEN cDNA 1520401O13 gene
4 gene 126.103860 126.141029 positive MGI_C57BL6J_1921428 Stk40 NCBI_Gene:74178,ENSEMBL:ENSMUSG00000042608 MGI:1921428 protein coding gene serine/threonine kinase 40
4 gene 126.145704 126.149875 positive MGI_C57BL6J_1922063 Eva1b NCBI_Gene:230752,ENSEMBL:ENSMUSG00000050212 MGI:1922063 protein coding gene eva-1 homolog B (C. elegans)
4 gene 126.145979 126.147735 positive MGI_C57BL6J_3650946 Gm12946 ENSEMBL:ENSMUSG00000086961 MGI:3650946 lncRNA gene predicted gene 12946
4 gene 126.150602 126.163998 negative MGI_C57BL6J_1914188 Sh3d21 NCBI_Gene:66938,ENSEMBL:ENSMUSG00000073758 MGI:1914188 protein coding gene SH3 domain containing 21
4 gene 126.164082 126.202760 negative MGI_C57BL6J_2442637 Thrap3 NCBI_Gene:230753,ENSEMBL:ENSMUSG00000043962 MGI:2442637 protein coding gene thyroid hormone receptor associated protein 3
4 gene 126.201175 126.201277 negative MGI_C57BL6J_5455100 Gm25323 ENSEMBL:ENSMUSG00000084504 MGI:5455100 snRNA gene predicted gene, 25323
4 gene 126.202878 126.203924 positive MGI_C57BL6J_1925109 D730050C22Rik NA NA unclassified gene RIKEN cDNA D730050C22 gene
4 gene 126.232167 126.256459 negative MGI_C57BL6J_2384297 Map7d1 NCBI_Gene:245877,ENSEMBL:ENSMUSG00000028849 MGI:2384297 protein coding gene MAP7 domain containing 1
4 gene 126.262325 126.275883 positive MGI_C57BL6J_1351486 Trappc3 NCBI_Gene:27096,ENSEMBL:ENSMUSG00000028847 MGI:1351486 protein coding gene trafficking protein particle complex 3
4 gene 126.286793 126.314330 positive MGI_C57BL6J_88464 Col8a2 NCBI_Gene:329941,ENSEMBL:ENSMUSG00000056174 MGI:88464 protein coding gene collagen, type VIII, alpha 2
4 gene 126.316047 126.321703 negative MGI_C57BL6J_2140364 Adprhl2 NCBI_Gene:100206,ENSEMBL:ENSMUSG00000042558 MGI:2140364 protein coding gene ADP-ribosylhydrolase like 2
4 gene 126.322116 126.325841 negative MGI_C57BL6J_1346335 Tekt2 NCBI_Gene:24084,ENSEMBL:ENSMUSG00000028845 MGI:1346335 protein coding gene tektin 2
4 gene 126.323599 126.325237 positive MGI_C57BL6J_3704237 Gm12945 ENSEMBL:ENSMUSG00000087394 MGI:3704237 lncRNA gene predicted gene 12945
4 gene 126.326989 126.429674 negative MGI_C57BL6J_2446634 Ago3 NCBI_Gene:214150,ENSEMBL:ENSMUSG00000028842 MGI:2446634 protein coding gene argonaute RISC catalytic subunit 3
4 gene 126.435012 126.468709 negative MGI_C57BL6J_2446630 Ago1 NCBI_Gene:236511,ENSEMBL:ENSMUSG00000041530 MGI:2446630 protein coding gene argonaute RISC catalytic subunit 1
4 pseudogene 126.476302 126.476671 negative MGI_C57BL6J_3652021 Gm12929 ENSEMBL:ENSMUSG00000084099 MGI:3652021 pseudogene predicted gene 12929
4 pseudogene 126.476727 126.477299 negative MGI_C57BL6J_3652022 Gm12928 ENSEMBL:ENSMUSG00000082381 MGI:3652022 pseudogene predicted gene 12928
4 gene 126.489541 126.533585 negative MGI_C57BL6J_1924100 Ago4 NCBI_Gene:76850,ENSEMBL:ENSMUSG00000042500 MGI:1924100 protein coding gene argonaute RISC catalytic subunit 4
4 pseudogene 126.521669 126.522087 positive MGI_C57BL6J_3651149 Gm12935 ENSEMBL:ENSMUSG00000083461 MGI:3651149 pseudogene predicted gene 12935
4 pseudogene 126.524330 126.524672 negative MGI_C57BL6J_3651150 Gm12934 ENSEMBL:ENSMUSG00000082888 MGI:3651150 pseudogene predicted gene 12934
4 gene 126.556935 126.594533 positive MGI_C57BL6J_2445153 Clspn NCBI_Gene:269582,ENSEMBL:ENSMUSG00000042489 MGI:2445153 protein coding gene claspin
4 gene 126.559860 126.559918 positive MGI_C57BL6J_5530942 Mir7119 miRBase:MI0022970,NCBI_Gene:102465673,ENSEMBL:ENSMUSG00000098831 MGI:5530942 miRNA gene microRNA 7119
4 pseudogene 126.584366 126.585111 negative MGI_C57BL6J_3651145 Gm12936 NCBI_Gene:102635893,ENSEMBL:ENSMUSG00000081319 MGI:3651145 pseudogene predicted gene 12936
4 gene 126.609818 126.614371 positive MGI_C57BL6J_3609248 5730409E04Rik NCBI_Gene:230757,ENSEMBL:ENSMUSG00000073755 MGI:3609248 protein coding gene RIKEN cDNA 5730409E04Rik gene
4 gene 126.614367 126.614787 negative MGI_C57BL6J_5623135 Gm40250 NCBI_Gene:105244688 MGI:5623135 lncRNA gene predicted gene, 40250
4 gene 126.616374 126.620297 negative MGI_C57BL6J_5826507 Gm46870 NCBI_Gene:108168978 MGI:5826507 lncRNA gene predicted gene, 46870
4 pseudogene 126.665229 126.666163 positive MGI_C57BL6J_3651147 Gm12933 NCBI_Gene:620877,ENSEMBL:ENSMUSG00000081210 MGI:3651147 pseudogene predicted gene 12933
4 gene 126.677630 126.709715 positive MGI_C57BL6J_1347045 Psmb2 NCBI_Gene:26445,ENSEMBL:ENSMUSG00000028837 MGI:1347045 protein coding gene proteasome (prosome, macropain) subunit, beta type 2
4 gene 126.699536 126.704029 positive MGI_C57BL6J_2442195 E330021A06Rik NA NA unclassified gene RIKEN cDNA E330021A06 gene
4 gene 126.716003 126.736269 negative MGI_C57BL6J_2679630 Tfap2e NCBI_Gene:332937,ENSEMBL:ENSMUSG00000042477 MGI:2679630 protein coding gene transcription factor AP-2, epsilon
4 gene 126.743750 126.753637 negative MGI_C57BL6J_1347351 Ncdn NCBI_Gene:26562,ENSEMBL:ENSMUSG00000028833 MGI:1347351 protein coding gene neurochondrin
4 gene 126.753544 126.870070 positive MGI_C57BL6J_2140475 AU040320 NCBI_Gene:100317,ENSEMBL:ENSMUSG00000028830 MGI:2140475 protein coding gene expressed sequence AU040320
4 pseudogene 126.795473 126.796415 negative MGI_C57BL6J_3650044 Gm12937 ENSEMBL:ENSMUSG00000082498 MGI:3650044 pseudogene predicted gene 12937
4 gene 126.818016 126.818145 negative MGI_C57BL6J_5453938 Gm24161 ENSEMBL:ENSMUSG00000077780 MGI:5453938 snoRNA gene predicted gene, 24161
4 gene 126.860980 126.861112 negative MGI_C57BL6J_5455381 Gm25604 ENSEMBL:ENSMUSG00000088984 MGI:5455381 snoRNA gene predicted gene, 25604
4 gene 126.861819 126.968844 negative MGI_C57BL6J_1915035 Zmym4 NCBI_Gene:67785,ENSEMBL:ENSMUSG00000042446 MGI:1915035 protein coding gene zinc finger, MYM-type 4
4 gene 126.968132 126.969379 positive MGI_C57BL6J_1918435 4933424C08Rik NA NA unclassified gene RIKEN cDNA 4933424C08 gene
4 pseudogene 126.983439 126.983603 positive MGI_C57BL6J_3652092 Gm12939 ENSEMBL:ENSMUSG00000081609 MGI:3652092 pseudogene predicted gene 12939
4 gene 127.020560 127.051101 positive MGI_C57BL6J_1918764 Sfpq NCBI_Gene:71514,ENSEMBL:ENSMUSG00000028820 MGI:1918764 protein coding gene splicing factor proline/glutamine rich (polypyrimidine tract binding protein associated)
4 gene 127.033731 127.049398 positive MGI_C57BL6J_3702626 Gm12940 ENSEMBL:ENSMUSG00000085334 MGI:3702626 lncRNA gene predicted gene 12940
4 pseudogene 127.046383 127.046602 positive MGI_C57BL6J_3650501 Gm12941 ENSEMBL:ENSMUSG00000084088 MGI:3650501 pseudogene predicted gene 12941
4 gene 127.047094 127.061172 negative MGI_C57BL6J_1915560 Zmym1 NCBI_Gene:68310,ENSEMBL:ENSMUSG00000043872 MGI:1915560 protein coding gene zinc finger, MYM domain containing 1
4 pseudogene 127.055910 127.056724 positive MGI_C57BL6J_3650498 Gm12944 NCBI_Gene:102635997,ENSEMBL:ENSMUSG00000084149 MGI:3650498 pseudogene predicted gene 12944
4 gene 127.077383 127.124374 positive MGI_C57BL6J_106505 Zmym6 NCBI_Gene:100177,ENSEMBL:ENSMUSG00000042408 MGI:106505 protein coding gene zinc finger, MYM-type 6
4 gene 127.108466 127.108571 negative MGI_C57BL6J_5455377 Gm25600 ENSEMBL:ENSMUSG00000088982 MGI:5455377 snRNA gene predicted gene, 25600
4 gene 127.123691 127.129660 positive MGI_C57BL6J_3758095 Tmem35b NCBI_Gene:100039968,ENSEMBL:ENSMUSG00000070737 MGI:3758095 protein coding gene transmembrane protein 35B
4 pseudogene 127.141201 127.141509 negative MGI_C57BL6J_3650497 Gm12943 NCBI_Gene:621588,ENSEMBL:ENSMUSG00000082220 MGI:3650497 pseudogene predicted gene 12943
4 gene 127.168483 127.237022 positive MGI_C57BL6J_3039563 Dlgap3 NCBI_Gene:242667,ENSEMBL:ENSMUSG00000042388 MGI:3039563 protein coding gene DLG associated protein 3
4 gene 127.243784 127.247809 positive MGI_C57BL6J_1933141 Smim12 NCBI_Gene:80284,ENSEMBL:ENSMUSG00000042380 MGI:1933141 protein coding gene small integral membrane protein 12
4 gene 127.248669 127.313366 positive MGI_C57BL6J_5592428 Gm33269 NCBI_Gene:102636104 MGI:5592428 lncRNA gene predicted gene, 33269
4 gene 127.284731 127.284833 negative MGI_C57BL6J_5451998 Gm22221 ENSEMBL:ENSMUSG00000087987 MGI:5451998 snRNA gene predicted gene, 22221
4 pseudogene 127.296784 127.297475 negative MGI_C57BL6J_3649530 Gm12948 NCBI_Gene:100417246,ENSEMBL:ENSMUSG00000082047 MGI:3649530 pseudogene predicted gene 12948
4 gene 127.311420 127.314039 negative MGI_C57BL6J_95715 Gja4 NCBI_Gene:14612,ENSEMBL:ENSMUSG00000050234 MGI:95715 protein coding gene gap junction protein, alpha 4
4 gene 127.325235 127.330844 negative MGI_C57BL6J_95721 Gjb3 NCBI_Gene:14620,ENSEMBL:ENSMUSG00000042367 MGI:95721 protein coding gene gap junction protein, beta 3
4 gene 127.329245 127.343262 positive MGI_C57BL6J_5623136 Gm40251 NCBI_Gene:105244689 MGI:5623136 lncRNA gene predicted gene, 40251
4 gene 127.340954 127.354139 negative MGI_C57BL6J_95722 Gjb4 NCBI_Gene:14621,ENSEMBL:ENSMUSG00000046623 MGI:95722 protein coding gene gap junction protein, beta 4
4 gene 127.354809 127.358181 negative MGI_C57BL6J_95723 Gjb5 NCBI_Gene:14622,ENSEMBL:ENSMUSG00000042357 MGI:95723 protein coding gene gap junction protein, beta 5
4 pseudogene 127.408337 127.409654 negative MGI_C57BL6J_3649527 Gm12947 NCBI_Gene:667296,ENSEMBL:ENSMUSG00000079998 MGI:3649527 pseudogene predicted gene 12947
4 gene 127.417126 127.424822 positive MGI_C57BL6J_5623137 Gm40252 NCBI_Gene:105244690 MGI:5623137 lncRNA gene predicted gene, 40252
4 gene 127.429043 127.429861 positive MGI_C57BL6J_5623138 Gm40253 NA NA lncRNA gene predicted gene%2c 40253
4 gene 127.474841 127.532885 positive MGI_C57BL6J_1920738 1700080G11Rik NCBI_Gene:73488,ENSEMBL:ENSMUSG00000086771 MGI:1920738 lncRNA gene RIKEN cDNA 1700080G11 gene
4 gene 127.474848 127.476840 positive MGI_C57BL6J_1925335 4930471C06Rik ENSEMBL:ENSMUSG00000086138 MGI:1925335 lncRNA gene RIKEN cDNA 4930471C06 gene
4 gene 127.545101 127.570502 positive MGI_C57BL6J_2444470 A630031M04Rik ENSEMBL:ENSMUSG00000087470 MGI:2444470 lncRNA gene RIKEN cDNA A630031M04 gene
4 gene 127.618745 127.619853 positive MGI_C57BL6J_5623140 Gm40255 NCBI_Gene:105244693 MGI:5623140 lncRNA gene predicted gene, 40255
4 gene 127.810638 127.812173 negative MGI_C57BL6J_1920846 1700112K13Rik ENSEMBL:ENSMUSG00000087510 MGI:1920846 lncRNA gene RIKEN cDNA 1700112K13 gene
4 gene 127.913883 127.916424 positive MGI_C57BL6J_5623141 Gm40256 NCBI_Gene:105244694 MGI:5623141 lncRNA gene predicted gene, 40256
4 gene 127.927592 127.988072 negative MGI_C57BL6J_3616080 CK137956 NCBI_Gene:635169,ENSEMBL:ENSMUSG00000028813 MGI:3616080 protein coding gene cDNA sequence CK137956
4 gene 127.971645 127.972450 positive MGI_C57BL6J_5621456 Gm38571 NCBI_Gene:102641725 MGI:5621456 lncRNA gene predicted gene, 38571
4 gene 127.987775 128.567660 positive MGI_C57BL6J_2386401 Csmd2 NCBI_Gene:329942,ENSEMBL:ENSMUSG00000028804 MGI:2386401 protein coding gene CUB and Sushi multiple domains 2
4 gene 128.132201 128.166967 negative MGI_C57BL6J_1922239 Csmd2os NCBI_Gene:74989,ENSEMBL:ENSMUSG00000087459 MGI:1922239 antisense lncRNA gene CUB and Sushi multiple domains 2, opposite strand
4 gene 128.260212 128.260957 negative MGI_C57BL6J_1916567 Hmgb4 NCBI_Gene:69317,ENSEMBL:ENSMUSG00000048686 MGI:1916567 protein coding gene high-mobility group box 4
4 gene 128.261044 128.262990 positive MGI_C57BL6J_1922492 Hmgb4os NCBI_Gene:75242,ENSEMBL:ENSMUSG00000085717 MGI:1922492 antisense lncRNA gene high-mobility group box 4, opposite strand
4 gene 128.506211 128.533358 negative MGI_C57BL6J_5592815 Gm33656 NCBI_Gene:102636648 MGI:5592815 lncRNA gene predicted gene, 33656
4 gene 128.578670 128.610176 negative MGI_C57BL6J_2679268 Zscan20 NCBI_Gene:269585,ENSEMBL:ENSMUSG00000061894 MGI:2679268 protein coding gene zinc finger and SCAN domains 20
4 gene 128.615443 128.618619 negative MGI_C57BL6J_3045221 Tlr12 NCBI_Gene:384059,ENSEMBL:ENSMUSG00000062545 MGI:3045221 protein coding gene toll-like receptor 12
4 gene 128.637238 128.639220 positive MGI_C57BL6J_3652007 Gm12958 NCBI_Gene:105244695,ENSEMBL:ENSMUSG00000084891 MGI:3652007 lncRNA gene predicted gene 12958
4 gene 128.654673 128.752881 positive MGI_C57BL6J_1860454 Phc2 NCBI_Gene:54383,ENSEMBL:ENSMUSG00000028796 MGI:1860454 protein coding gene polyhomeotic 2
4 gene 128.721282 128.727535 negative MGI_C57BL6J_5592871 Gm33712 NA NA unclassified non-coding RNA gene predicted gene%2c 33712
4 gene 128.755364 128.770201 positive MGI_C57BL6J_2685279 A3galt2 NCBI_Gene:215493,ENSEMBL:ENSMUSG00000028794 MGI:2685279 protein coding gene alpha 1,3-galactosyltransferase 2 (isoglobotriaosylceramide synthase)
4 gene 128.773085 128.806112 negative MGI_C57BL6J_2652839 Zfp362 NCBI_Gene:230761,ENSEMBL:ENSMUSG00000028799 MGI:2652839 protein coding gene zinc finger protein 362
4 gene 128.846197 128.873698 positive MGI_C57BL6J_3649345 Gm12968 ENSEMBL:ENSMUSG00000085701 MGI:3649345 lncRNA gene predicted gene 12968
4 pseudogene 128.867954 128.869422 negative MGI_C57BL6J_3650134 Gm12969 NCBI_Gene:667354,ENSEMBL:ENSMUSG00000084011 MGI:3650134 pseudogene predicted gene 12969
4 gene 128.871998 128.877440 negative MGI_C57BL6J_5592973 Gm33814 NCBI_Gene:102636861 MGI:5592973 lncRNA gene predicted gene, 33814
4 gene 128.877639 128.882332 positive MGI_C57BL6J_5592919 Gm33760 NA NA unclassified non-coding RNA gene predicted gene%2c 33760
4 gene 128.881692 128.911332 positive MGI_C57BL6J_1914775 Trim62 NCBI_Gene:67525,ENSEMBL:ENSMUSG00000041000 MGI:1914775 protein coding gene tripartite motif-containing 62
4 gene 128.917334 128.922263 positive MGI_C57BL6J_5593060 Gm33901 NCBI_Gene:102636978 MGI:5593060 lncRNA gene predicted gene, 33901
4 gene 128.930233 128.962460 negative MGI_C57BL6J_2442093 Azin2 NCBI_Gene:242669,ENSEMBL:ENSMUSG00000028789 MGI:2442093 protein coding gene antizyme inhibitor 2
4 gene 128.935971 128.940199 positive MGI_C57BL6J_3801803 Gm15904 NCBI_Gene:105244696,ENSEMBL:ENSMUSG00000085961 MGI:3801803 lncRNA gene predicted gene 15904
4 gene 128.991958 129.011529 positive MGI_C57BL6J_87978 Ak2 NCBI_Gene:11637,ENSEMBL:ENSMUSG00000028792 MGI:87978 protein coding gene adenylate kinase 2
4 gene 129.050087 129.058122 negative MGI_C57BL6J_1914599 1700086P04Rik NCBI_Gene:67349,ENSEMBL:ENSMUSG00000085085 MGI:1914599 lncRNA gene RIKEN cDNA 1700086P04 gene
4 gene 129.058146 129.085886 positive MGI_C57BL6J_1922484 Rnf19b NCBI_Gene:75234,ENSEMBL:ENSMUSG00000028793 MGI:1922484 protein coding gene ring finger protein 19B
4 gene 129.105519 129.111626 positive MGI_C57BL6J_1913510 Tmem54 NCBI_Gene:66260,ENSEMBL:ENSMUSG00000028786 MGI:1913510 protein coding gene transmembrane protein 54
4 gene 129.111570 129.122074 negative MGI_C57BL6J_1336200 Hpca NCBI_Gene:15444,ENSEMBL:ENSMUSG00000028785 MGI:1336200 protein coding gene hippocalcin
4 gene 129.135091 129.136910 positive MGI_C57BL6J_3801906 Gm15906 ENSEMBL:ENSMUSG00000087416 MGI:3801906 lncRNA gene predicted gene 15906
4 gene 129.136921 129.144593 positive MGI_C57BL6J_1917614 Fndc5 NCBI_Gene:384061,ENSEMBL:ENSMUSG00000001334 MGI:1917614 protein coding gene fibronectin type III domain containing 5
4 gene 129.148002 129.189735 negative MGI_C57BL6J_1921898 S100pbp NCBI_Gene:74648,ENSEMBL:ENSMUSG00000040928 MGI:1921898 protein coding gene S100P binding protein
4 gene 129.189760 129.219607 positive MGI_C57BL6J_2147627 Yars NCBI_Gene:107271,ENSEMBL:ENSMUSG00000028811 MGI:2147627 protein coding gene tyrosyl-tRNA synthetase
4 gene 129.219578 129.261404 negative MGI_C57BL6J_2140651 C77080 NCBI_Gene:97130,ENSEMBL:ENSMUSG00000050390 MGI:2140651 protein coding gene expressed sequence C77080
4 gene 129.239417 129.286806 positive MGI_C57BL6J_3650499 Gm12976 NCBI_Gene:102637131,ENSEMBL:ENSMUSG00000087575 MGI:3650499 lncRNA gene predicted gene 12976
4 gene 129.282865 129.282946 negative MGI_C57BL6J_5452771 Gm22994 ENSEMBL:ENSMUSG00000093163 MGI:5452771 miRNA gene predicted gene, 22994
4 gene 129.287536 129.309386 positive MGI_C57BL6J_1916078 Sync NCBI_Gene:68828,ENSEMBL:ENSMUSG00000001333 MGI:1916078 protein coding gene syncoilin
4 gene 129.307100 129.335372 negative MGI_C57BL6J_1194912 Rbbp4 NCBI_Gene:19646,ENSEMBL:ENSMUSG00000057236 MGI:1194912 protein coding gene retinoblastoma binding protein 4, chromatin remodeling factor
4 gene 129.309081 129.318443 positive MGI_C57BL6J_5477216 Gm26722 ENSEMBL:ENSMUSG00000096944 MGI:5477216 lncRNA gene predicted gene, 26722
4 gene 129.335592 129.354547 positive MGI_C57BL6J_1914356 Zbtb8os NCBI_Gene:67106,ENSEMBL:ENSMUSG00000057572 MGI:1914356 protein coding gene zinc finger and BTB domain containing 8 opposite strand
4 gene 129.353628 129.378116 negative MGI_C57BL6J_1920930 Zbtb8a NCBI_Gene:73680,ENSEMBL:ENSMUSG00000028807 MGI:1920930 protein coding gene zinc finger and BTB domain containing 8a
4 pseudogene 129.379844 129.380179 positive MGI_C57BL6J_3651320 Gm12980 ENSEMBL:ENSMUSG00000082468 MGI:3651320 pseudogene predicted gene 12980
4 gene 129.382546 129.407475 positive MGI_C57BL6J_2444986 C330020E22Rik NCBI_Gene:320896 MGI:2444986 lncRNA gene RIKEN cDNA C330020E22 gene
4 gene 129.425765 129.446776 negative MGI_C57BL6J_2387181 Zbtb8b NCBI_Gene:215627,ENSEMBL:ENSMUSG00000048485 MGI:2387181 protein coding gene zinc finger and BTB domain containing 8b
4 gene 129.458351 129.458490 positive MGI_C57BL6J_5454398 Gm24621 ENSEMBL:ENSMUSG00000064613 MGI:5454398 snRNA gene predicted gene, 24621
4 gene 129.460172 129.461524 negative MGI_C57BL6J_1918074 4921504P20Rik NA NA unclassified gene RIKEN cDNA 4921504P20 gene
4 gene 129.461581 129.488498 positive MGI_C57BL6J_1913466 Bsdc1 NCBI_Gene:100383,ENSEMBL:ENSMUSG00000040859 MGI:1913466 protein coding gene BSD domain containing 1
4 gene 129.489008 129.491022 negative MGI_C57BL6J_1929914 Tssk3 NCBI_Gene:58864,ENSEMBL:ENSMUSG00000000411 MGI:1929914 protein coding gene testis-specific serine kinase 3
4 gene 129.491190 129.491956 positive MGI_C57BL6J_1915483 Fam229a NCBI_Gene:68233,ENSEMBL:ENSMUSG00000078554 MGI:1915483 protein coding gene family with sequence similarity 229, member A
4 gene 129.491969 129.509746 negative MGI_C57BL6J_3651303 Gm12979 ENSEMBL:ENSMUSG00000086336 MGI:3651303 lncRNA gene predicted gene 12979
4 gene 129.513581 129.515985 positive MGI_C57BL6J_97143 Marcksl1 NCBI_Gene:17357,ENSEMBL:ENSMUSG00000047945 MGI:97143 protein coding gene MARCKS-like 1
4 gene 129.516104 129.542713 negative MGI_C57BL6J_108086 Hdac1 NCBI_Gene:433759,ENSEMBL:ENSMUSG00000028800 MGI:108086 protein coding gene histone deacetylase 1
4 gene 129.548344 129.573641 negative MGI_C57BL6J_96756 Lck NCBI_Gene:16818,ENSEMBL:ENSMUSG00000000409 MGI:96756 protein coding gene lymphocyte protein tyrosine kinase
4 gene 129.557683 129.557811 negative MGI_C57BL6J_5530949 Mir8119 miRBase:MI0026051,NCBI_Gene:102465997,ENSEMBL:ENSMUSG00000099070 MGI:5530949 miRNA gene microRNA 8119
4 gene 129.576815 129.578580 negative MGI_C57BL6J_2668032 Fam167b NCBI_Gene:230766,ENSEMBL:ENSMUSG00000050493 MGI:2668032 protein coding gene family with sequence similarity 167, member B
4 gene 129.591960 129.600648 negative MGI_C57BL6J_1860763 Eif3i NCBI_Gene:54709,ENSEMBL:ENSMUSG00000028798 MGI:1860763 protein coding gene eukaryotic translation initiation factor 3, subunit I
4 gene 129.600668 129.624059 positive MGI_C57BL6J_1924049 Tmem234 NCBI_Gene:76799,ENSEMBL:ENSMUSG00000028797 MGI:1924049 protein coding gene transmembrane protein 234
4 gene 129.608331 129.614479 negative MGI_C57BL6J_2686212 Dcdc2b NCBI_Gene:100504491,ENSEMBL:ENSMUSG00000078552 MGI:2686212 protein coding gene doublecortin domain containing 2b
4 gene 129.615126 129.619107 negative MGI_C57BL6J_2446212 Iqcc NCBI_Gene:230767,ENSEMBL:ENSMUSG00000040795 MGI:2446212 protein coding gene IQ motif containing C
4 gene 129.619274 129.623947 negative MGI_C57BL6J_1913514 Ccdc28b NCBI_Gene:66264,ENSEMBL:ENSMUSG00000028795 MGI:1913514 protein coding gene coiled coil domain containing 28B
4 gene 129.623106 129.624060 positive MGI_C57BL6J_5593464 Gm34305 NCBI_Gene:102637517 MGI:5593464 lncRNA gene predicted gene, 34305
4 gene 129.624254 129.625072 negative MGI_C57BL6J_1920034 2810452K05Rik NA NA unclassified gene RIKEN cDNA 2810452K05 gene
4 gene 129.626077 129.641065 negative MGI_C57BL6J_105968 Txlna NCBI_Gene:109658,ENSEMBL:ENSMUSG00000053841 MGI:105968 protein coding gene taxilin alpha
4 gene 129.643979 129.672767 negative MGI_C57BL6J_1100836 Kpna6 NCBI_Gene:16650,ENSEMBL:ENSMUSG00000003731 MGI:1100836 protein coding gene karyopherin (importin) alpha 6
4 gene 129.676355 129.696846 negative MGI_C57BL6J_2682939 Tmem39b NCBI_Gene:230770,ENSEMBL:ENSMUSG00000053730 MGI:2682939 protein coding gene transmembrane protein 39b
4 gene 129.684500 129.684571 negative MGI_C57BL6J_5531376 Mir7016 miRBase:MI0022865,NCBI_Gene:102465615,ENSEMBL:ENSMUSG00000098422 MGI:5531376 miRNA gene microRNA 7016
4 gene 129.702380 129.742768 negative MGI_C57BL6J_893579 Khdrbs1 NCBI_Gene:20218,ENSEMBL:ENSMUSG00000028790 MGI:893579 protein coding gene KH domain containing, RNA binding, signal transduction associated 1
4 pseudogene 129.761583 129.761916 negative MGI_C57BL6J_3652042 Gm12967 NCBI_Gene:100040532,ENSEMBL:ENSMUSG00000080944 MGI:3652042 pseudogene predicted gene 12967
4 gene 129.762311 129.762436 negative MGI_C57BL6J_5531399 Gm28017 ENSEMBL:ENSMUSG00000099322 MGI:5531399 miRNA gene predicted gene, 28017
4 gene 129.811219 129.850003 positive MGI_C57BL6J_1277117 Ptp4a2 NCBI_Gene:19244,ENSEMBL:ENSMUSG00000028788 MGI:1277117 protein coding gene protein tyrosine phosphatase 4a2
4 gene 129.820747 129.822053 positive MGI_C57BL6J_1923343 5830469G19Rik NA NA unclassified gene RIKEN cDNA 5830469G19 gene
4 gene 129.852503 129.853676 negative MGI_C57BL6J_1921548 1700108I11Rik NCBI_Gene:105244698 MGI:1921548 lncRNA gene RIKEN cDNA 1700108I11 gene
4 pseudogene 129.855071 129.856710 positive MGI_C57BL6J_3708701 Gm10571 ENSEMBL:ENSMUSG00000073753 MGI:3708701 pseudogene predicted gene 10571
4 gene 129.895573 129.895724 positive MGI_C57BL6J_5453622 Gm23845 ENSEMBL:ENSMUSG00000065768 MGI:5453622 snRNA gene predicted gene, 23845
4 pseudogene 129.898949 129.900435 positive MGI_C57BL6J_3652043 Gm12966 NCBI_Gene:622469,ENSEMBL:ENSMUSG00000070729 MGI:3652043 pseudogene predicted gene 12966
4 gene 129.906216 129.919787 positive MGI_C57BL6J_2442924 E330017L17Rik NCBI_Gene:319894,ENSEMBL:ENSMUSG00000086369 MGI:2442924 lncRNA gene RIKEN cDNA E330017L17 gene
4 gene 129.928767 129.957115 positive MGI_C57BL6J_3652045 Spocd1 NCBI_Gene:622480,ENSEMBL:ENSMUSG00000028784 MGI:3652045 protein coding gene SPOC domain containing 1
4 gene 129.960374 129.965138 positive MGI_C57BL6J_1919475 1700003M07Rik NCBI_Gene:72225,ENSEMBL:ENSMUSG00000085389 MGI:1919475 lncRNA gene RIKEN cDNA 1700003M07 gene
4 gene 129.984870 130.022633 positive MGI_C57BL6J_2451244 Adgrb2 NCBI_Gene:230775,ENSEMBL:ENSMUSG00000028782 MGI:2451244 protein coding gene adhesion G protein-coupled receptor B2
4 gene 130.022980 130.049668 negative MGI_C57BL6J_3651569 Gm12963 NCBI_Gene:102640839,ENSEMBL:ENSMUSG00000085517 MGI:3651569 lncRNA gene predicted gene 12963
4 gene 130.047426 130.099283 positive MGI_C57BL6J_1095396 Col16a1 NCBI_Gene:107581,ENSEMBL:ENSMUSG00000040690 MGI:1095396 protein coding gene collagen, type XVI, alpha 1
4 gene 130.076240 130.079510 negative MGI_C57BL6J_5826508 Gm46871 NCBI_Gene:108168980 MGI:5826508 lncRNA gene predicted gene, 46871
4 gene 130.102558 130.128135 positive MGI_C57BL6J_1915148 Pef1 NCBI_Gene:67898,ENSEMBL:ENSMUSG00000028779 MGI:1915148 protein coding gene penta-EF hand domain containing 1
4 gene 130.105455 130.108282 negative MGI_C57BL6J_5623143 Gm40258 NCBI_Gene:105244699 MGI:5623143 lncRNA gene predicted gene, 40258
4 gene 130.130217 130.139694 negative MGI_C57BL6J_2385650 Hcrtr1 NCBI_Gene:230777,ENSEMBL:ENSMUSG00000028778 MGI:2385650 protein coding gene hypocretin (orexin) receptor 1
4 gene 130.143954 130.148919 positive MGI_C57BL6J_5623144 Gm40259 NCBI_Gene:105244700 MGI:5623144 lncRNA gene predicted gene, 40259
4 gene 130.164454 130.175122 negative MGI_C57BL6J_2137617 Tinagl1 NCBI_Gene:94242,ENSEMBL:ENSMUSG00000028776 MGI:2137617 protein coding gene tubulointerstitial nephritis antigen-like 1
4 gene 130.209025 130.222428 negative MGI_C57BL6J_2685699 Ldc1 NCBI_Gene:332942,ENSEMBL:ENSMUSG00000023120 MGI:2685699 protein coding gene leucine decarboxylase 1
4 gene 130.236579 130.249079 positive MGI_C57BL6J_5826361 Gm46724 NCBI_Gene:108168712 MGI:5826361 lncRNA gene predicted gene, 46724
4 gene 130.253495 130.279205 negative MGI_C57BL6J_1919132 Serinc2 NCBI_Gene:230779,ENSEMBL:ENSMUSG00000023232 MGI:1919132 protein coding gene serine incorporator 2
4 gene 130.275656 130.280859 positive MGI_C57BL6J_5594116 Gm34957 NCBI_Gene:102638376 MGI:5594116 lncRNA gene predicted gene, 34957
4 gene 130.291197 130.308674 negative MGI_C57BL6J_3642427 Gm10570 NCBI_Gene:102638454,ENSEMBL:ENSMUSG00000073752 MGI:3642427 lncRNA gene predicted gene 10570
4 gene 130.308595 130.315463 positive MGI_C57BL6J_95476 Fabp3 NCBI_Gene:14077,ENSEMBL:ENSMUSG00000028773 MGI:95476 protein coding gene fatty acid binding protein 3, muscle and heart
4 gene 130.315383 130.359963 negative MGI_C57BL6J_1919955 Zcchc17 NCBI_Gene:619605,ENSEMBL:ENSMUSG00000028772 MGI:1919955 protein coding gene zinc finger, CCHC domain containing 17
4 gene 130.317693 130.333346 positive MGI_C57BL6J_5594233 Gm35074 NCBI_Gene:102638533 MGI:5594233 lncRNA gene predicted gene, 35074
4 gene 130.360132 130.390033 positive MGI_C57BL6J_1913835 Snrnp40 NCBI_Gene:66585,ENSEMBL:ENSMUSG00000074088 MGI:1913835 protein coding gene small nuclear ribonucleoprotein 40 (U5)
4 gene 130.370979 130.372023 negative MGI_C57BL6J_1922417 4930527F18Rik NA NA unclassified gene RIKEN cDNA 4930527F18 gene
4 gene 130.379910 130.380785 positive MGI_C57BL6J_1920110 2900017G11Rik NA NA unclassified gene RIKEN cDNA 2900017G11 gene
4 gene 130.530131 130.574173 negative MGI_C57BL6J_1914399 Nkain1 NCBI_Gene:67149,ENSEMBL:ENSMUSG00000078532 MGI:1914399 protein coding gene Na+/K+ transporting ATPase interacting 1
4 gene 130.572296 130.573053 negative MGI_C57BL6J_1916206 1500006G06Rik NA NA unclassified gene RIKEN cDNA 1500006G06 gene
4 gene 130.663297 130.781564 positive MGI_C57BL6J_1931749 Pum1 NCBI_Gene:80912,ENSEMBL:ENSMUSG00000028580 MGI:1931749 protein coding gene pumilio RNA-binding family member 1
4 gene 130.709672 130.710490 positive MGI_C57BL6J_1919888 2810017D21Rik NA NA unclassified gene RIKEN cDNA 2810017D21 gene
4 gene 130.749634 130.749706 positive MGI_C57BL6J_3819558 Snord85 NCBI_Gene:100217460,ENSEMBL:ENSMUSG00000065196 MGI:3819558 snoRNA gene small nucleolar RNA, C/D box 85
4 gene 130.758563 130.762379 positive MGI_C57BL6J_3650041 Gm12971 ENSEMBL:ENSMUSG00000087449 MGI:3650041 lncRNA gene predicted gene 12971
4 gene 130.766331 130.766413 positive MGI_C57BL6J_5453868 Gm24091 ENSEMBL:ENSMUSG00000093793 MGI:5453868 snoRNA gene predicted gene, 24091
4 gene 130.774817 130.779246 negative MGI_C57BL6J_5477010 Gm26516 ENSEMBL:ENSMUSG00000097158 MGI:5477010 lncRNA gene predicted gene, 26516
4 gene 130.775741 130.775823 positive MGI_C57BL6J_5453488 Gm23711 ENSEMBL:ENSMUSG00000095119 MGI:5453488 snoRNA gene predicted gene, 23711
4 gene 130.784530 130.788003 positive MGI_C57BL6J_3650043 Gm12972 NCBI_Gene:108168710,ENSEMBL:ENSMUSG00000086548 MGI:3650043 lncRNA gene predicted gene 12972
4 gene 130.792537 130.826319 positive MGI_C57BL6J_1349163 Sdc3 NCBI_Gene:20970,ENSEMBL:ENSMUSG00000025743 MGI:1349163 protein coding gene syndecan 3
4 gene 130.811617 130.812326 negative MGI_C57BL6J_3650040 Gm12970 ENSEMBL:ENSMUSG00000087451 MGI:3650040 lncRNA gene predicted gene 12970
4 gene 130.824394 130.826313 negative MGI_C57BL6J_5477210 Gm26716 ENSEMBL:ENSMUSG00000097224 MGI:5477210 lncRNA gene predicted gene, 26716
4 gene 130.827769 130.834247 negative MGI_C57BL6J_5625201 Gm42316 NCBI_Gene:105247171 MGI:5625201 lncRNA gene predicted gene, 42316
4 gene 130.857751 130.857880 negative MGI_C57BL6J_5452437 Gm22660 ENSEMBL:ENSMUSG00000077381 MGI:5452437 snoRNA gene predicted gene, 22660
4 gene 130.871050 130.872898 positive MGI_C57BL6J_5594453 Gm35294 NCBI_Gene:102638819 MGI:5594453 lncRNA gene predicted gene, 35294
4 gene 130.906051 130.914563 negative MGI_C57BL6J_5621484 Gm38599 NCBI_Gene:102642196 MGI:5621484 lncRNA gene predicted gene, 38599
4 gene 130.912890 130.936148 positive MGI_C57BL6J_108046 Laptm5 NCBI_Gene:16792,ENSEMBL:ENSMUSG00000028581 MGI:108046 protein coding gene lysosomal-associated protein transmembrane 5
4 gene 130.944385 130.955476 positive MGI_C57BL6J_106591 Matn1 NCBI_Gene:17180,ENSEMBL:ENSMUSG00000040533 MGI:106591 protein coding gene matrilin 1, cartilage matrix protein
4 gene 130.974742 131.001339 positive MGI_C57BL6J_3650042 Gm12973 NCBI_Gene:108168713,ENSEMBL:ENSMUSG00000085804 MGI:3650042 lncRNA gene predicted gene 12973
4 gene 131.000832 131.010474 negative MGI_C57BL6J_1925085 A930031H19Rik NCBI_Gene:77835,ENSEMBL:ENSMUSG00000086262 MGI:1925085 lncRNA gene RIKEN cDNA A930031H19 gene
4 gene 131.063855 131.065645 negative MGI_C57BL6J_5625202 Gm42317 NCBI_Gene:105247172 MGI:5625202 lncRNA gene predicted gene, 42317
4 gene 131.075667 131.080271 negative MGI_C57BL6J_5594641 Gm35482 NCBI_Gene:102639082 MGI:5594641 lncRNA gene predicted gene, 35482
4 gene 131.156346 131.162675 positive MGI_C57BL6J_5625203 Gm42318 NCBI_Gene:105247173 MGI:5625203 lncRNA gene predicted gene, 42318
4 gene 131.239277 131.239410 positive MGI_C57BL6J_5455038 Gm25261 ENSEMBL:ENSMUSG00000088041 MGI:5455038 snoRNA gene predicted gene, 25261
4 gene 131.409139 131.428303 positive MGI_C57BL6J_5594793 Gm35634 NCBI_Gene:102639287 MGI:5594793 lncRNA gene predicted gene, 35634
4 gene 131.456305 131.482614 positive MGI_C57BL6J_5826360 Gm46723 NCBI_Gene:108168711 MGI:5826360 lncRNA gene predicted gene, 46723
4 gene 131.458415 131.485455 negative MGI_C57BL6J_5594938 Gm35779 NCBI_Gene:102639475 MGI:5594938 lncRNA gene predicted gene, 35779
4 gene 131.487197 131.505527 positive MGI_C57BL6J_2685677 Gm831 NCBI_Gene:329950,ENSEMBL:ENSMUSG00000078531 MGI:2685677 lncRNA gene predicted gene 831
4 gene 131.617437 131.635082 positive MGI_C57BL6J_5625205 Gm42320 NCBI_Gene:105247175 MGI:5625205 lncRNA gene predicted gene, 42320
4 gene 131.647048 131.677845 negative MGI_C57BL6J_3650901 Gm12962 ENSEMBL:ENSMUSG00000087171 MGI:3650901 lncRNA gene predicted gene 12962
4 gene 131.647059 131.710512 negative MGI_C57BL6J_5625206 Gm42321 NCBI_Gene:105247176 MGI:5625206 lncRNA gene predicted gene, 42321
4 gene 131.694607 131.710508 negative MGI_C57BL6J_3802056 Gm16080 ENSEMBL:ENSMUSG00000086856 MGI:3802056 lncRNA gene predicted gene 16080
4 gene 131.768457 131.838314 negative MGI_C57BL6J_1321151 Ptpru NCBI_Gene:19273,ENSEMBL:ENSMUSG00000028909 MGI:1321151 protein coding gene protein tyrosine phosphatase, receptor type, U
4 gene 131.843443 131.867787 positive MGI_C57BL6J_1349441 Mecr NCBI_Gene:26922,ENSEMBL:ENSMUSG00000028910 MGI:1349441 protein coding gene mitochondrial trans-2-enoyl-CoA reductase
4 gene 131.873612 131.901725 positive MGI_C57BL6J_1890577 Srsf4 NCBI_Gene:57317,ENSEMBL:ENSMUSG00000028911 MGI:1890577 protein coding gene serine/arginine-rich splicing factor 4
4 gene 131.878628 131.883237 positive MGI_C57BL6J_2442442 A930004J17Rik ENSEMBL:ENSMUSG00000102602 MGI:2442442 unclassified gene RIKEN cDNA A930004J17 gene
4 gene 131.887903 131.889417 positive MGI_C57BL6J_1918083 4733401A01Rik NA NA unclassified gene RIKEN cDNA 4733401A01 gene
4 gene 131.899478 131.920029 negative MGI_C57BL6J_3702644 Gm12992 NCBI_Gene:545681,ENSEMBL:ENSMUSG00000085667 MGI:3702644 lncRNA gene predicted gene 12992
4 pseudogene 131.902733 131.903326 negative MGI_C57BL6J_3705382 Gm12978 NCBI_Gene:100418326,ENSEMBL:ENSMUSG00000083013 MGI:3705382 pseudogene predicted gene 12978
4 gene 131.919971 131.923956 positive MGI_C57BL6J_3646343 Tmem200b NCBI_Gene:623230,ENSEMBL:ENSMUSG00000070720 MGI:3646343 protein coding gene transmembrane protein 200B
4 gene 131.920816 131.921528 negative MGI_C57BL6J_6324745 Gm50475 ENSEMBL:ENSMUSG00000118394 MGI:6324745 lncRNA gene predicted gene, 50475
4 gene 131.923413 132.075579 negative MGI_C57BL6J_95401 Epb41 NCBI_Gene:269587,ENSEMBL:ENSMUSG00000028906 MGI:95401 protein coding gene erythrocyte membrane protein band 4.1
4 gene 131.992218 131.992289 negative MGI_C57BL6J_5530827 Gm27445 ENSEMBL:ENSMUSG00000098577 MGI:5530827 miRNA gene predicted gene, 27445
4 gene 132.048178 132.048961 positive MGI_C57BL6J_3649474 Gm13063 ENSEMBL:ENSMUSG00000084869 MGI:3649474 lncRNA gene predicted gene 13063
4 gene 132.049534 132.049802 positive MGI_C57BL6J_5595316 Gm36157 NCBI_Gene:102639968 MGI:5595316 lncRNA gene predicted gene, 36157
4 gene 132.074697 132.076992 positive MGI_C57BL6J_3641670 Gm10300 ENSEMBL:ENSMUSG00000070717 MGI:3641670 protein coding gene predicted gene 10300
4 pseudogene 132.093891 132.094298 positive MGI_C57BL6J_3650812 Gm13214 ENSEMBL:ENSMUSG00000083368 MGI:3650812 pseudogene predicted gene 13214
4 gene 132.104830 132.109363 negative MGI_C57BL6J_5610939 Gm37711 ENSEMBL:ENSMUSG00000102796 MGI:5610939 unclassified gene predicted gene, 37711
4 gene 132.107669 132.144486 negative MGI_C57BL6J_97438 Oprd1 NCBI_Gene:18386,ENSEMBL:ENSMUSG00000050511 MGI:97438 protein coding gene opioid receptor, delta 1
4 gene 132.125259 132.125330 positive MGI_C57BL6J_4413695 n-TAcgc3 NCBI_Gene:102467236 MGI:4413695 tRNA gene nuclear encoded tRNA alanine 3 (anticodon CGC)
4 pseudogene 132.148399 132.148920 negative MGI_C57BL6J_3650813 Gm13215 NCBI_Gene:664894,ENSEMBL:ENSMUSG00000081394 MGI:3650813 pseudogene predicted gene 13215
4 gene 132.184912 132.212303 negative MGI_C57BL6J_2444233 Ythdf2 NCBI_Gene:213541,ENSEMBL:ENSMUSG00000040025 MGI:2444233 protein coding gene YTH N6-methyladenosine RNA binding protein 2
4 gene 132.218439 132.218528 negative MGI_C57BL6J_5451810 Gm22033 ENSEMBL:ENSMUSG00000080597 MGI:5451810 miRNA gene predicted gene, 22033
4 pseudogene 132.219893 132.220589 negative MGI_C57BL6J_3652187 Rps15a-ps4 NCBI_Gene:664903,ENSEMBL:ENSMUSG00000083757 MGI:3652187 pseudogene ribosomal protein S15A, pseudogene 4
4 gene 132.221025 132.261602 negative MGI_C57BL6J_2135604 Gmeb1 NCBI_Gene:56809,ENSEMBL:ENSMUSG00000028901 MGI:2135604 protein coding gene glucocorticoid modulatory element binding protein 1
4 pseudogene 132.244685 132.245979 negative MGI_C57BL6J_3651953 Gm13252 NCBI_Gene:105247177,ENSEMBL:ENSMUSG00000084105 MGI:3651953 pseudogene predicted gene 13252
4 gene 132.260536 132.268841 positive MGI_C57BL6J_5579580 Gm28874 NCBI_Gene:102640216,ENSEMBL:ENSMUSG00000100813 MGI:5579580 lncRNA gene predicted gene 28874
4 gene 132.270056 132.270213 positive MGI_C57BL6J_5579578 Gm28872 ENSEMBL:ENSMUSG00000099937 MGI:5579578 lncRNA gene predicted gene 28872
4 gene 132.270079 132.270213 negative MGI_C57BL6J_2148804 Rnu11 NCBI_Gene:353373,ENSEMBL:ENSMUSG00000077323 MGI:2148804 snRNA gene U11 small nuclear RNA
4 gene 132.274096 132.274282 negative MGI_C57BL6J_3629726 Gt(pU21)115Imeg NA NA unclassified gene gene trap 115%2c Institute of Molecular Embryology and Genetics
4 gene 132.274355 132.295766 positive MGI_C57BL6J_1913714 Taf12 NCBI_Gene:66464,ENSEMBL:ENSMUSG00000028899 MGI:1913714 protein coding gene TATA-box binding protein associated factor 12
4 gene 132.300438 132.303403 negative MGI_C57BL6J_2441753 Rab42 NCBI_Gene:242681,ENSEMBL:ENSMUSG00000089687 MGI:2441753 protein coding gene RAB42, member RAS oncogene family
4 gene 132.308623 132.311024 positive MGI_C57BL6J_1916721 Snhg12 NCBI_Gene:100039864,ENSEMBL:ENSMUSG00000086290 MGI:1916721 lncRNA gene small nucleolar RNA host gene 12
4 gene 132.309464 132.309600 positive MGI_C57BL6J_4361141 Snora16a NCBI_Gene:100310813,ENSEMBL:ENSMUSG00000065097,ENSEMBL:ENSMUSG00000105911 MGI:4361141 snoRNA gene small nucleolar RNA, H/ACA box 16A
4 gene 132.309941 132.310069 positive MGI_C57BL6J_3819506 Snora44 NCBI_Gene:100217418,ENSEMBL:ENSMUSG00000064604 MGI:3819506 snoRNA gene small nucleolar RNA, H/ACA box 44
4 gene 132.310240 132.310369 positive MGI_C57BL6J_3819510 Snora61 NCBI_Gene:100217440,ENSEMBL:ENSMUSG00000064949 MGI:3819510 snoRNA gene small nucleolar RNA, H/ACA box 61
4 gene 132.310691 132.310764 positive MGI_C57BL6J_3819570 Snord99 NCBI_Gene:100217437,ENSEMBL:ENSMUSG00000080615 MGI:3819570 snoRNA gene small nucleolar RNA, C/D box 99
4 gene 132.311763 132.329545 negative MGI_C57BL6J_1919037 Trnau1ap NCBI_Gene:71787,ENSEMBL:ENSMUSG00000028898 MGI:1919037 protein coding gene tRNA selenocysteine 1 associated protein 1
4 gene 132.331919 132.353605 negative MGI_C57BL6J_1913989 Rcc1 NCBI_Gene:100088,ENSEMBL:ENSMUSG00000028896 MGI:1913989 protein coding gene regulator of chromosome condensation 1
4 gene 132.348014 132.353686 negative MGI_C57BL6J_2684817 Snhg3 NCBI_Gene:399101,ENSEMBL:ENSMUSG00000085241 MGI:2684817 lncRNA gene small nucleolar RNA host gene 3
4 gene 132.351772 132.353382 positive MGI_C57BL6J_4936934 Gm17300 ENSEMBL:ENSMUSG00000091021 MGI:4936934 lncRNA gene predicted gene, 17300
4 gene 132.352322 132.352526 negative MGI_C57BL6J_4360049 Snora73b NCBI_Gene:100306945,ENSEMBL:ENSMUSG00000065353 MGI:4360049 snoRNA gene small nucleolar RNA, H/ACA box 73b
4 gene 132.352775 132.352979 negative MGI_C57BL6J_4360046 Snora73a NCBI_Gene:100306944,ENSEMBL:ENSMUSG00000064387 MGI:4360046 snoRNA gene small nucleolar RNA, H/ACA box 73a
4 gene 132.355922 132.422489 negative MGI_C57BL6J_2140327 Phactr4 NCBI_Gene:100169,ENSEMBL:ENSMUSG00000066043 MGI:2140327 protein coding gene phosphatase and actin regulator 4
4 gene 132.408309 132.408404 positive MGI_C57BL6J_5455484 Gm25707 ENSEMBL:ENSMUSG00000096350 MGI:5455484 miRNA gene predicted gene, 25707
4 gene 132.442034 132.442127 positive MGI_C57BL6J_5452832 Gm23055 ENSEMBL:ENSMUSG00000064739 MGI:5452832 snRNA gene predicted gene, 23055
4 gene 132.458729 132.463921 negative MGI_C57BL6J_1914469 Med18 NCBI_Gene:67219,ENSEMBL:ENSMUSG00000066042 MGI:1914469 protein coding gene mediator complex subunit 18
4 gene 132.492032 132.510501 negative MGI_C57BL6J_2651874 Sesn2 NCBI_Gene:230784,ENSEMBL:ENSMUSG00000028893 MGI:2651874 protein coding gene sestrin 2
4 gene 132.503561 132.509649 negative MGI_C57BL6J_3651528 Gm12981 ENSEMBL:ENSMUSG00000086997 MGI:3651528 lncRNA gene predicted gene 12981
4 gene 132.516008 132.516079 positive MGI_C57BL6J_4413681 n-TAagc8 NCBI_Gene:102467230 MGI:4413681 tRNA gene nuclear encoded tRNA alanine 8 (anticodon AGC)
4 gene 132.530555 132.535414 negative MGI_C57BL6J_1196457 Atpif1 NCBI_Gene:11983,ENSEMBL:ENSMUSG00000054428 MGI:1196457 protein coding gene ATPase inhibitory factor 1
4 gene 132.532687 132.533601 positive MGI_C57BL6J_3651167 Gm12999 ENSEMBL:ENSMUSG00000087352 MGI:3651167 lncRNA gene predicted gene 12999
4 gene 132.535550 132.553742 positive MGI_C57BL6J_1915848 Dnajc8 NCBI_Gene:68598,ENSEMBL:ENSMUSG00000054405 MGI:1915848 protein coding gene DnaJ heat shock protein family (Hsp40) member C8
4 gene 132.547104 132.547207 negative MGI_C57BL6J_5454539 Gm24762 ENSEMBL:ENSMUSG00000065623 MGI:5454539 snRNA gene predicted gene, 24762
4 gene 132.564067 132.582683 positive MGI_C57BL6J_106066 Ptafr NCBI_Gene:19204,ENSEMBL:ENSMUSG00000056529 MGI:106066 protein coding gene platelet-activating factor receptor
4 gene 132.638987 132.724765 positive MGI_C57BL6J_109339 Eya3 NCBI_Gene:14050,ENSEMBL:ENSMUSG00000028886 MGI:109339 protein coding gene EYA transcriptional coactivator and phosphatase 3
4 gene 132.639102 132.640270 positive MGI_C57BL6J_1923270 5830409B07Rik NA NA unclassified gene RIKEN cDNA 5830409B07 gene
4 gene 132.724897 132.732606 negative MGI_C57BL6J_2685877 Xkr8 NCBI_Gene:381560,ENSEMBL:ENSMUSG00000037752 MGI:2685877 protein coding gene X-linked Kx blood group related 8
4 gene 132.732966 132.757252 negative MGI_C57BL6J_1916022 Smpdl3b NCBI_Gene:100340,ENSEMBL:ENSMUSG00000028885 MGI:1916022 protein coding gene sphingomyelin phosphodiesterase, acid-like 3B
4 gene 132.768332 132.778752 positive MGI_C57BL6J_1339939 Rpa2 NCBI_Gene:19891,ENSEMBL:ENSMUSG00000028884 MGI:1339939 protein coding gene replication protein A2
4 gene 132.781837 132.796387 negative MGI_C57BL6J_2446213 Themis2 NCBI_Gene:230787,ENSEMBL:ENSMUSG00000037731 MGI:2446213 protein coding gene thymocyte selection associated family member 2
4 pseudogene 132.801970 132.802254 negative MGI_C57BL6J_3651775 Gm13022 ENSEMBL:ENSMUSG00000081647 MGI:3651775 pseudogene predicted gene 13022
4 gene 132.826924 132.843169 negative MGI_C57BL6J_2140494 Ppp1r8 NCBI_Gene:100336,ENSEMBL:ENSMUSG00000028882 MGI:2140494 protein coding gene protein phosphatase 1, regulatory subunit 8
4 gene 132.838383 132.838547 negative MGI_C57BL6J_5452544 Gm22767 ENSEMBL:ENSMUSG00000088990 MGI:5452544 snoRNA gene predicted gene, 22767
4 gene 132.853501 132.884509 negative MGI_C57BL6J_1931027 Stx12 NCBI_Gene:100226,ENSEMBL:ENSMUSG00000028879 MGI:1931027 protein coding gene syntaxin 12
4 gene 132.882170 132.883337 negative MGI_C57BL6J_1924875 C530007A02Rik NA NA unclassified gene RIKEN cDNA C530007A02 gene
4 pseudogene 132.884763 132.886626 positive MGI_C57BL6J_3649305 Gm13033 NCBI_Gene:100038703,ENSEMBL:ENSMUSG00000083816 MGI:3649305 pseudogene predicted gene 13033
4 gene 132.899213 132.923128 negative MGI_C57BL6J_2385211 Fam76a NCBI_Gene:230789,ENSEMBL:ENSMUSG00000028878 MGI:2385211 protein coding gene family with sequence similarity 76, member A
4 gene 132.931211 132.931317 negative MGI_C57BL6J_5454690 Gm24913 ENSEMBL:ENSMUSG00000087911 MGI:5454690 snRNA gene predicted gene, 24913
4 gene 132.948422 132.960681 negative MGI_C57BL6J_5595677 Gm36518 NCBI_Gene:102640462 MGI:5595677 lncRNA gene predicted gene, 36518
4 gene 132.974095 133.001910 positive MGI_C57BL6J_95527 Fgr NCBI_Gene:14191,ENSEMBL:ENSMUSG00000028874 MGI:95527 protein coding gene FGR proto-oncogene, Src family tyrosine kinase
4 gene 133.002707 133.008152 negative MGI_C57BL6J_5595758 Gm36599 NCBI_Gene:102640565 MGI:5595758 lncRNA gene predicted gene, 36599
4 gene 133.011260 133.078110 positive MGI_C57BL6J_2444218 Ahdc1 NCBI_Gene:230793,ENSEMBL:ENSMUSG00000037692 MGI:2444218 protein coding gene AT hook, DNA binding motif, containing 1
4 gene 133.083352 133.089146 positive MGI_C57BL6J_5477109 Gm26615 NCBI_Gene:102640635,ENSEMBL:ENSMUSG00000097088 MGI:5477109 lncRNA gene predicted gene, 26615
4 gene 133.114496 133.114566 negative MGI_C57BL6J_4413870 n-TGgcc1 NCBI_Gene:102467429 MGI:4413870 tRNA gene nuclear encoded tRNA glycine 1 (anticodon GCC)
4 gene 133.130505 133.199756 positive MGI_C57BL6J_1098641 Wasf2 NCBI_Gene:242687,ENSEMBL:ENSMUSG00000028868 MGI:1098641 protein coding gene WAS protein family, member 2
4 gene 133.171427 133.171714 negative MGI_C57BL6J_5454413 Gm24636 ENSEMBL:ENSMUSG00000089298 MGI:5454413 unclassified non-coding RNA gene predicted gene, 24636
4 gene 133.195655 133.195716 positive MGI_C57BL6J_5531327 Mir7017 miRBase:MI0022866,NCBI_Gene:102466215,ENSEMBL:ENSMUSG00000099202 MGI:5531327 miRNA gene microRNA 7017
4 gene 133.209340 133.212536 negative MGI_C57BL6J_101908 Gpr3 NCBI_Gene:14748,ENSEMBL:ENSMUSG00000049649 MGI:101908 protein coding gene G-protein coupled receptor 3
4 gene 133.212131 133.224555 positive MGI_C57BL6J_1916905 Cd164l2 NCBI_Gene:69655,ENSEMBL:ENSMUSG00000028865 MGI:1916905 protein coding gene CD164 sialomucin-like 2
4 pseudogene 133.231545 133.239286 positive MGI_C57BL6J_3510254 Fcnc-ps NCBI_Gene:493918 MGI:3510254 pseudogene ficolin C pseudogene
4 gene 133.239657 133.252929 positive MGI_C57BL6J_1855691 Map3k6 NCBI_Gene:53608,ENSEMBL:ENSMUSG00000028862 MGI:1855691 protein coding gene mitogen-activated protein kinase kinase kinase 6
4 gene 133.253090 133.263113 negative MGI_C57BL6J_1933365 Sytl1 NCBI_Gene:269589,ENSEMBL:ENSMUSG00000028860 MGI:1933365 protein coding gene synaptotagmin-like 1
4 gene 133.266045 133.277792 negative MGI_C57BL6J_1098568 Tmem222 NCBI_Gene:52174,ENSEMBL:ENSMUSG00000028857 MGI:1098568 protein coding gene transmembrane protein 222
4 pseudogene 133.280857 133.281312 negative MGI_C57BL6J_3700962 Gm13259 ENSEMBL:ENSMUSG00000083241 MGI:3700962 pseudogene predicted gene 13259
4 gene 133.292459 133.353481 negative MGI_C57BL6J_2685541 Wdtc1 NCBI_Gene:230796,ENSEMBL:ENSMUSG00000037622 MGI:2685541 protein coding gene WD and tetratricopeptide repeats 1
4 gene 133.292466 133.292785 positive MGI_C57BL6J_3781803 Gm3627 NA NA protein coding gene predicted gene 3627
4 gene 133.369706 133.423702 positive MGI_C57BL6J_102462 Slc9a1 NCBI_Gene:20544,ENSEMBL:ENSMUSG00000028854 MGI:102462 protein coding gene solute carrier family 9 (sodium/hydrogen exchanger), member 1
4 gene 133.369776 133.369864 positive MGI_C57BL6J_4950447 Mir5122 miRBase:MI0018031,NCBI_Gene:100628620,ENSEMBL:ENSMUSG00000092745 MGI:4950447 miRNA gene microRNA 5122
4 gene 133.432739 133.434897 negative MGI_C57BL6J_1920802 1700091J24Rik NCBI_Gene:105247178 MGI:1920802 lncRNA gene RIKEN cDNA 1700091J24 gene
4 gene 133.437060 133.440366 negative MGI_C57BL6J_5625207 Gm42322 NCBI_Gene:105247179 MGI:5625207 lncRNA gene predicted gene, 42322
4 gene 133.479356 133.485183 negative MGI_C57BL6J_3651057 Gm13257 NCBI_Gene:102640829,ENSEMBL:ENSMUSG00000086850 MGI:3651057 lncRNA gene predicted gene 13257
4 gene 133.480132 133.487940 positive MGI_C57BL6J_2140500 Tent5b NCBI_Gene:100342,ENSEMBL:ENSMUSG00000046694 MGI:2140500 protein coding gene terminal nucleotidyltransferase 5B
4 gene 133.491097 133.499225 negative MGI_C57BL6J_1916789 Trnp1 NCBI_Gene:69539,ENSEMBL:ENSMUSG00000056596 MGI:1916789 protein coding gene TMF1-regulated nuclear protein 1
4 gene 133.512874 133.522320 negative MGI_C57BL6J_5625208 Gm42323 NCBI_Gene:105247180 MGI:5625208 protein coding gene predicted gene, 42323
4 gene 133.518923 133.530790 positive MGI_C57BL6J_1916323 Kdf1 NCBI_Gene:69073,ENSEMBL:ENSMUSG00000037600 MGI:1916323 protein coding gene keratinocyte differentiation factor 1
4 gene 133.532542 133.546027 negative MGI_C57BL6J_106014 Nudc NCBI_Gene:18221,ENSEMBL:ENSMUSG00000028851 MGI:106014 protein coding gene nudC nuclear distribution protein
4 gene 133.553376 133.556686 positive MGI_C57BL6J_1346344 Nr0b2 NCBI_Gene:23957,ENSEMBL:ENSMUSG00000037583 MGI:1346344 protein coding gene nuclear receptor subfamily 0, group B, member 2
4 gene 133.558824 133.558949 negative MGI_C57BL6J_5452935 Gm23158 ENSEMBL:ENSMUSG00000093886 MGI:5452935 miRNA gene predicted gene, 23158
4 gene 133.574745 133.584243 positive MGI_C57BL6J_2442492 Gpatch3 NCBI_Gene:242691,ENSEMBL:ENSMUSG00000028850 MGI:2442492 protein coding gene G patch domain containing 3
4 gene 133.584362 133.591735 positive MGI_C57BL6J_2140368 Gpn2 NCBI_Gene:100210,ENSEMBL:ENSMUSG00000028848 MGI:2140368 protein coding gene GPN-loop GTPase 2
4 gene 133.594939 133.596007 negative MGI_C57BL6J_5625209 Gm42324 NCBI_Gene:105247181 MGI:5625209 lncRNA gene predicted gene, 42324
4 gene 133.600556 133.602168 negative MGI_C57BL6J_1891831 Sfn NCBI_Gene:55948,ENSEMBL:ENSMUSG00000047281 MGI:1891831 protein coding gene stratifin
4 gene 133.604656 133.650154 negative MGI_C57BL6J_3527792 Zdhhc18 NCBI_Gene:503610,ENSEMBL:ENSMUSG00000037553 MGI:3527792 protein coding gene zinc finger, DHHC domain containing 18
4 pseudogene 133.638097 133.650622 negative MGI_C57BL6J_3651606 Gm13213 NCBI_Gene:545683,ENSEMBL:ENSMUSG00000083885 MGI:3651606 pseudogene predicted gene 13213
4 gene 133.654002 133.654257 positive MGI_C57BL6J_5452439 Gm22662 ENSEMBL:ENSMUSG00000093031 MGI:5452439 unclassified non-coding RNA gene predicted gene, 22662
4 gene 133.659914 133.673241 negative MGI_C57BL6J_2442480 Pigv NCBI_Gene:230801,ENSEMBL:ENSMUSG00000043257 MGI:2442480 protein coding gene phosphatidylinositol glycan anchor biosynthesis, class V
4 gene 133.672719 133.673237 positive MGI_C57BL6J_1920565 1700041L08Rik NA NA unclassified gene RIKEN cDNA 1700041L08 gene
4 gene 133.679008 133.756769 negative MGI_C57BL6J_1935147 Arid1a NCBI_Gene:93760,ENSEMBL:ENSMUSG00000007880 MGI:1935147 protein coding gene AT rich interactive domain 1A (SWI-like)
4 gene 133.717050 133.717108 negative MGI_C57BL6J_5562763 Mir7227 miRBase:MI0023722,NCBI_Gene:102465707,ENSEMBL:ENSMUSG00000104566 MGI:5562763 miRNA gene microRNA 7227
4 gene 133.768128 133.775447 negative MGI_C57BL6J_5589178 Gm30019 NCBI_Gene:102631762 MGI:5589178 lncRNA gene predicted gene, 30019
4 gene 133.774969 133.781279 positive MGI_C57BL6J_5589101 Gm29942 NCBI_Gene:102631659 MGI:5589101 lncRNA gene predicted gene, 29942
4 gene 133.792037 133.821546 negative MGI_C57BL6J_5593455 Gm34296 NCBI_Gene:102637505 MGI:5593455 lncRNA gene predicted gene, 34296
4 gene 133.797582 133.797719 negative MGI_C57BL6J_5455047 Gm25270 ENSEMBL:ENSMUSG00000084555 MGI:5455047 snRNA gene predicted gene, 25270
4 gene 133.815238 133.821631 positive MGI_C57BL6J_3650037 Gm12974 NCBI_Gene:105247182,ENSEMBL:ENSMUSG00000084789 MGI:3650037 lncRNA gene predicted gene 12974
4 gene 133.847290 133.887797 negative MGI_C57BL6J_104558 Rps6ka1 NCBI_Gene:20111,ENSEMBL:ENSMUSG00000003644 MGI:104558 protein coding gene ribosomal protein S6 kinase polypeptide 1
4 gene 133.871639 133.877167 positive MGI_C57BL6J_3650699 Gm12977 NCBI_Gene:102631939,ENSEMBL:ENSMUSG00000085009 MGI:3650699 lncRNA gene predicted gene 12977
4 pseudogene 133.882945 133.883127 negative MGI_C57BL6J_3651383 Gm12985 ENSEMBL:ENSMUSG00000080946 MGI:3651383 pseudogene predicted gene 12985
4 gene 133.883399 133.883498 negative MGI_C57BL6J_5452300 Gm22523 ENSEMBL:ENSMUSG00000089321 MGI:5452300 snRNA gene predicted gene, 22523
4 gene 133.911038 133.911444 negative MGI_C57BL6J_1921148 4930429E23Rik NA NA unclassified gene RIKEN cDNA 4930429E23 gene
4 gene 133.964738 133.968650 negative MGI_C57BL6J_96136 Hmgn2 NCBI_Gene:15331,ENSEMBL:ENSMUSG00000003038 MGI:96136 protein coding gene high mobility group nucleosomal binding domain 2
4 gene 133.969028 134.000918 negative MGI_C57BL6J_1914672 Dhdds NCBI_Gene:67422,ENSEMBL:ENSMUSG00000012117 MGI:1914672 protein coding gene dehydrodolichyl diphosphate synthase
4 gene 134.003330 134.019202 negative MGI_C57BL6J_1890546 Lin28a NCBI_Gene:83557,ENSEMBL:ENSMUSG00000050966 MGI:1890546 protein coding gene lin-28 homolog A (C. elegans)
4 gene 134.003363 134.004884 positive MGI_C57BL6J_3710625 Gm10299 NA NA unclassified gene predicted gene 10299
4 gene 134.018147 134.019869 positive MGI_C57BL6J_3650259 Gm13061 ENSEMBL:ENSMUSG00000087288 MGI:3650259 lncRNA gene predicted gene 13061
4 gene 134.051195 134.058996 positive MGI_C57BL6J_3650254 Zfp683 NCBI_Gene:100503878,ENSEMBL:ENSMUSG00000049410 MGI:3650254 protein coding gene zinc finger protein 683
4 gene 134.060729 134.092504 positive MGI_C57BL6J_1334463 Crybg2 NCBI_Gene:230806,ENSEMBL:ENSMUSG00000012123 MGI:1334463 protein coding gene crystallin beta-gamma domain containing 2
4 gene 134.082448 134.095082 negative MGI_C57BL6J_1346088 Cd52 NCBI_Gene:23833,ENSEMBL:ENSMUSG00000000682 MGI:1346088 protein coding gene CD52 antigen
4 gene 134.102520 134.127593 positive MGI_C57BL6J_1914836 Ubxn11 NCBI_Gene:67586,ENSEMBL:ENSMUSG00000012126 MGI:1914836 protein coding gene UBX domain protein 11
4 gene 134.127406 134.128789 negative MGI_C57BL6J_1920973 Sh3bgrl3 NCBI_Gene:73723,ENSEMBL:ENSMUSG00000028843 MGI:1920973 protein coding gene SH3 domain binding glutamic acid-rich protein-like 3
4 gene 134.129858 134.187112 negative MGI_C57BL6J_1917262 Cep85 NCBI_Gene:70012,ENSEMBL:ENSMUSG00000037443 MGI:1917262 protein coding gene centrosomal protein 85
4 gene 134.159957 134.164109 positive MGI_C57BL6J_5826531 Gm46894 NCBI_Gene:108169013 MGI:5826531 protein coding gene predicted gene, 46894
4 gene 134.167808 134.167895 negative MGI_C57BL6J_5531001 Gm27619 ENSEMBL:ENSMUSG00000098693 MGI:5531001 snoRNA gene predicted gene, 27619
4 gene 134.190804 134.203004 negative MGI_C57BL6J_3702974 Gm7534 NCBI_Gene:665186,ENSEMBL:ENSMUSG00000073747 MGI:3702974 protein coding gene predicted gene 7534
4 pseudogene 134.199830 134.200150 negative MGI_C57BL6J_3651062 Gm13131 ENSEMBL:ENSMUSG00000081772 MGI:3651062 pseudogene predicted gene 13131
4 gene 134.211968 134.227431 negative MGI_C57BL6J_3043288 Catsper4 NCBI_Gene:329954,ENSEMBL:ENSMUSG00000048003 MGI:3043288 protein coding gene cation channel, sperm associated 4
4 gene 134.228041 134.238420 negative MGI_C57BL6J_2670958 Cnksr1 NCBI_Gene:194231,ENSEMBL:ENSMUSG00000028841 MGI:2670958 protein coding gene connector enhancer of kinase suppressor of Ras 1
4 gene 134.243289 134.245592 negative MGI_C57BL6J_1915290 Zfp593 NCBI_Gene:68040,ENSEMBL:ENSMUSG00000028840 MGI:1915290 protein coding gene zinc finger protein 593
4 gene 134.243662 134.245873 positive MGI_C57BL6J_3528958 E130218I03Rik NCBI_Gene:77490,ENSEMBL:ENSMUSG00000086322 MGI:3528958 lncRNA gene RIKEN cDNA E130218I03 gene
4 gene 134.246935 134.250042 positive MGI_C57BL6J_5589350 Gm30191 ENSEMBL:ENSMUSG00000108398 MGI:5589350 protein coding gene predicted gene, 30191
4 gene 134.251102 134.266197 negative MGI_C57BL6J_1919940 Grrp1 NCBI_Gene:72690,ENSEMBL:ENSMUSG00000050105 MGI:1919940 protein coding gene glycine/arginine rich protein 1
4 gene 134.255786 134.265655 positive MGI_C57BL6J_5625210 Gm42325 NCBI_Gene:105247183 MGI:5625210 lncRNA gene predicted gene, 42325
4 gene 134.275002 134.287895 negative MGI_C57BL6J_2385213 Pdik1l NCBI_Gene:230809,ENSEMBL:ENSMUSG00000050890 MGI:2385213 protein coding gene PDLIM1 interacting kinase 1 like
4 gene 134.315120 134.329629 positive MGI_C57BL6J_2447992 Trim63 NCBI_Gene:433766,ENSEMBL:ENSMUSG00000028834 MGI:2447992 protein coding gene tripartite motif-containing 63
4 pseudogene 134.335498 134.335758 negative MGI_C57BL6J_3652269 Gm13195 ENSEMBL:ENSMUSG00000083065 MGI:3652269 pseudogene predicted gene 13195
4 gene 134.343046 134.354484 positive MGI_C57BL6J_106637 Slc30a2 NCBI_Gene:230810,ENSEMBL:ENSMUSG00000028836 MGI:106637 protein coding gene solute carrier family 30 (zinc transporter), member 2
4 gene 134.356372 134.383850 negative MGI_C57BL6J_1888742 Extl1 NCBI_Gene:56219,ENSEMBL:ENSMUSG00000028838 MGI:1888742 protein coding gene exostoses (multiple)-like 1
4 gene 134.384933 134.386978 positive MGI_C57BL6J_3779501 Gm5589 NA NA unclassified gene predicted gene 5589
4 gene 134.396320 134.427413 positive MGI_C57BL6J_2140321 Pafah2 NCBI_Gene:100163,ENSEMBL:ENSMUSG00000037366 MGI:2140321 protein coding gene platelet-activating factor acetylhydrolase 2
4 gene 134.433692 134.448283 negative MGI_C57BL6J_5589612 Gm30453 NCBI_Gene:102632361 MGI:5589612 lncRNA gene predicted gene, 30453
4 gene 134.448765 134.450171 negative MGI_C57BL6J_1916659 1700021N21Rik NCBI_Gene:69409,ENSEMBL:ENSMUSG00000087343 MGI:1916659 lncRNA gene RIKEN cDNA 1700021N21 gene
4 gene 134.468320 134.473843 positive MGI_C57BL6J_96739 Stmn1 NCBI_Gene:16765,ENSEMBL:ENSMUSG00000028832 MGI:96739 protein coding gene stathmin 1
4 gene 134.468364 134.468454 positive MGI_C57BL6J_5453411 Gm23634 ENSEMBL:ENSMUSG00000092812 MGI:5453411 miRNA gene predicted gene, 23634
4 pseudogene 134.493210 134.493974 positive MGI_C57BL6J_3650425 Gm13250 NCBI_Gene:100416260,ENSEMBL:ENSMUSG00000083001 MGI:3650425 pseudogene predicted gene 13250
4 gene 134.496697 134.510237 positive MGI_C57BL6J_1919154 Paqr7 NCBI_Gene:71904,ENSEMBL:ENSMUSG00000037348 MGI:1919154 protein coding gene progestin and adipoQ receptor family member VII
4 gene 134.510999 134.523927 positive MGI_C57BL6J_1917135 Aunip NCBI_Gene:69885,ENSEMBL:ENSMUSG00000078521 MGI:1917135 protein coding gene aurora kinase A and ninein interacting protein
4 gene 134.525550 134.535387 negative MGI_C57BL6J_1924074 Mtfr1l NCBI_Gene:76824,ENSEMBL:ENSMUSG00000046671 MGI:1924074 protein coding gene mitochondrial fission regulator 1-like
4 gene 134.537892 134.552166 negative MGI_C57BL6J_2151208 Selenon NCBI_Gene:74777,ENSEMBL:ENSMUSG00000050989 MGI:2151208 protein coding gene selenoprotein N
4 gene 134.561690 134.704290 negative MGI_C57BL6J_2446214 Man1c1 NCBI_Gene:230815,ENSEMBL:ENSMUSG00000037306 MGI:2446214 protein coding gene mannosidase, alpha, class 1C, member 1
4 gene 134.567723 134.567851 negative MGI_C57BL6J_5531374 Mir6403 miRBase:MI0021939,NCBI_Gene:102465216,ENSEMBL:ENSMUSG00000099289 MGI:5531374 miRNA gene microRNA 6403
4 gene 134.591443 134.594972 positive MGI_C57BL6J_5625211 Gm42326 NCBI_Gene:105247184 MGI:5625211 lncRNA gene predicted gene, 42326
4 gene 134.741554 134.768024 negative MGI_C57BL6J_2140175 Ldlrap1 NCBI_Gene:100017,ENSEMBL:ENSMUSG00000037295 MGI:2140175 protein coding gene low density lipoprotein receptor adaptor protein 1
4 gene 134.802759 134.853556 negative MGI_C57BL6J_1913396 Maco1 NCBI_Gene:66146,ENSEMBL:ENSMUSG00000028826 MGI:1913396 protein coding gene macoilin 1
4 gene 134.864536 134.896172 positive MGI_C57BL6J_1202882 Rhd NCBI_Gene:19746,ENSEMBL:ENSMUSG00000028825 MGI:1202882 protein coding gene Rh blood group, D antigen
4 gene 134.897849 134.915030 negative MGI_C57BL6J_1919067 Tmem50a NCBI_Gene:71817,ENSEMBL:ENSMUSG00000028822 MGI:1919067 protein coding gene transmembrane protein 50A
4 gene 134.923592 134.927671 positive MGI_C57BL6J_106498 Rsrp1 NCBI_Gene:27981,ENSEMBL:ENSMUSG00000037266 MGI:106498 protein coding gene arginine/serine rich protein 1
4 gene 134.930898 134.937548 positive MGI_C57BL6J_1915842 Syf2 NCBI_Gene:68592,ENSEMBL:ENSMUSG00000028821 MGI:1915842 protein coding gene SYF2 homolog, RNA splicing factor (S. cerevisiae)
4 gene 135.043698 135.051367 negative MGI_C57BL6J_5625212 Gm42327 NCBI_Gene:105247185 MGI:5625212 lncRNA gene predicted gene, 42327
4 gene 135.118221 135.120447 negative MGI_C57BL6J_3801903 Gm16225 ENSEMBL:ENSMUSG00000086884 MGI:3801903 lncRNA gene predicted gene 16225
4 gene 135.120645 135.177990 positive MGI_C57BL6J_102672 Runx3 NCBI_Gene:12399,ENSEMBL:ENSMUSG00000070691 MGI:102672 protein coding gene runt related transcription factor 3
4 gene 135.143421 135.144285 negative MGI_C57BL6J_3801902 Gm16224 ENSEMBL:ENSMUSG00000084986 MGI:3801902 lncRNA gene predicted gene 16224
4 gene 135.213969 135.272814 negative MGI_C57BL6J_1352754 Clic4 NCBI_Gene:29876,ENSEMBL:ENSMUSG00000037242 MGI:1352754 protein coding gene chloride intracellular channel 4 (mitochondrial)
4 gene 135.283067 135.289144 positive MGI_C57BL6J_5589926 Gm30767 NCBI_Gene:102632783 MGI:5589926 lncRNA gene predicted gene, 30767
4 pseudogene 135.290269 135.290718 negative MGI_C57BL6J_3651378 Gm12983 NCBI_Gene:676072,ENSEMBL:ENSMUSG00000087270 MGI:3651378 pseudogene predicted gene 12983
4 gene 135.296609 135.299416 negative MGI_C57BL6J_5589860 Gm30701 NCBI_Gene:102632698 MGI:5589860 lncRNA gene predicted gene, 30701
4 gene 135.307349 135.309519 positive MGI_C57BL6J_3651384 Gm12984 ENSEMBL:ENSMUSG00000085002 MGI:3651384 lncRNA gene predicted gene 12984
4 pseudogene 135.307781 135.307970 negative MGI_C57BL6J_3651381 Gm12982 ENSEMBL:ENSMUSG00000082833 MGI:3651381 pseudogene predicted gene 12982
4 gene 135.320484 135.353321 negative MGI_C57BL6J_1858303 Srrm1 NCBI_Gene:51796,ENSEMBL:ENSMUSG00000028809 MGI:1858303 protein coding gene serine/arginine repetitive matrix 1
4 gene 135.369576 135.398253 negative MGI_C57BL6J_2444888 Ncmap NCBI_Gene:230822,ENSEMBL:ENSMUSG00000043924 MGI:2444888 protein coding gene noncompact myelin associated protein
4 pseudogene 135.377158 135.377235 positive MGI_C57BL6J_3651750 Gm12991 ENSEMBL:ENSMUSG00000084032 MGI:3651750 pseudogene predicted gene 12991
4 pseudogene 135.403189 135.403656 negative MGI_C57BL6J_3651107 Gm12990 ENSEMBL:ENSMUSG00000081136 MGI:3651107 pseudogene predicted gene 12990
4 gene 135.412308 135.433870 negative MGI_C57BL6J_1858220 Rcan3 NCBI_Gene:53902,ENSEMBL:ENSMUSG00000059713 MGI:1858220 protein coding gene regulator of calcineurin 3
4 gene 135.416555 135.416633 negative MGI_C57BL6J_3629655 Mir700 miRBase:MI0004684,NCBI_Gene:735285,ENSEMBL:ENSMUSG00000076123 MGI:3629655 miRNA gene microRNA 700
4 gene 135.420678 135.427794 positive MGI_C57BL6J_5589981 Gm30822 NCBI_Gene:102632859 MGI:5589981 lncRNA gene predicted gene, 30822
4 gene 135.430126 135.430841 negative MGI_C57BL6J_3801882 Gm15979 ENSEMBL:ENSMUSG00000087016 MGI:3801882 lncRNA gene predicted gene 15979
4 gene 135.445420 135.495038 negative MGI_C57BL6J_1921802 Nipal3 NCBI_Gene:74552,ENSEMBL:ENSMUSG00000028803 MGI:1921802 protein coding gene NIPA-like domain containing 3
4 gene 135.450881 135.451210 positive MGI_C57BL6J_5610498 Gm37270 ENSEMBL:ENSMUSG00000103955 MGI:5610498 unclassified gene predicted gene, 37270
4 gene 135.494790 135.537803 positive MGI_C57BL6J_1926056 Stpg1 NCBI_Gene:78806,ENSEMBL:ENSMUSG00000028801 MGI:1926056 protein coding gene sperm tail PG rich repeat containing 1
4 gene 135.512351 135.512479 negative MGI_C57BL6J_5455094 Gm25317 ENSEMBL:ENSMUSG00000080474 MGI:5455094 miRNA gene predicted gene, 25317
4 gene 135.541887 135.573630 negative MGI_C57BL6J_2655333 Grhl3 NCBI_Gene:230824,ENSEMBL:ENSMUSG00000037188 MGI:2655333 protein coding gene grainyhead like transcription factor 3
4 gene 135.573580 135.580174 positive MGI_C57BL6J_5590047 Gm30888 NCBI_Gene:102632942 MGI:5590047 lncRNA gene predicted gene, 30888
4 gene 135.583748 135.583848 positive MGI_C57BL6J_5452883 Gm23106 ENSEMBL:ENSMUSG00000088179 MGI:5452883 snRNA gene predicted gene, 23106
4 gene 135.626655 135.630198 positive MGI_C57BL6J_1913597 1700029M20Rik NCBI_Gene:73937,ENSEMBL:ENSMUSG00000086788 MGI:1913597 lncRNA gene RIKEN cDNA 1700029M20 gene
4 gene 135.650254 135.654000 negative MGI_C57BL6J_5590100 Gm30941 NCBI_Gene:102633011 MGI:5590100 lncRNA gene predicted gene, 30941
4 gene 135.686287 135.708181 positive MGI_C57BL6J_2429859 Ifnlr1 NCBI_Gene:242700,ENSEMBL:ENSMUSG00000062157 MGI:2429859 protein coding gene interferon lambda receptor 1
4 pseudogene 135.715728 135.716698 negative MGI_C57BL6J_3652245 Gm12989 NCBI_Gene:100418217,ENSEMBL:ENSMUSG00000083678 MGI:3652245 pseudogene predicted gene 12989
4 gene 135.728159 135.755383 positive MGI_C57BL6J_2663588 Il22ra1 NCBI_Gene:230828,ENSEMBL:ENSMUSG00000037157 MGI:2663588 protein coding gene interleukin 22 receptor, alpha 1
4 pseudogene 135.755575 135.756777 negative MGI_C57BL6J_3650876 Gm12988 NCBI_Gene:665334,ENSEMBL:ENSMUSG00000082743 MGI:3650876 pseudogene predicted gene 12988
4 gene 135.758796 135.815571 positive MGI_C57BL6J_2685280 Myom3 NCBI_Gene:242702,ENSEMBL:ENSMUSG00000037139 MGI:2685280 protein coding gene myomesin family, member 3
4 pseudogene 135.853678 135.854173 positive MGI_C57BL6J_3650940 Gm13000 ENSEMBL:ENSMUSG00000081672 MGI:3650940 pseudogene predicted gene 13000
4 gene 135.855728 135.869908 positive MGI_C57BL6J_1333805 Srsf10 NCBI_Gene:14105,ENSEMBL:ENSMUSG00000028676 MGI:1333805 protein coding gene serine/arginine-rich splicing factor 10
4 gene 135.870917 135.873850 negative MGI_C57BL6J_106512 Pnrc2 NCBI_Gene:52830,ENSEMBL:ENSMUSG00000028675 MGI:106512 protein coding gene proline-rich nuclear receptor coactivator 2
4 pseudogene 135.891264 135.891477 negative MGI_C57BL6J_3651355 Gm13006 ENSEMBL:ENSMUSG00000083430 MGI:3651355 pseudogene predicted gene 13006
4 gene 135.895189 135.920219 positive MGI_C57BL6J_104650 Cnr2 NCBI_Gene:12802,ENSEMBL:ENSMUSG00000062585 MGI:104650 protein coding gene cannabinoid receptor 2 (macrophage)
4 gene 135.920726 135.940311 positive MGI_C57BL6J_95593 Fuca1 NCBI_Gene:71665,ENSEMBL:ENSMUSG00000028673 MGI:95593 protein coding gene fucosidase, alpha-L- 1, tissue
4 gene 135.946448 135.962617 positive MGI_C57BL6J_96158 Hmgcl NCBI_Gene:15356,ENSEMBL:ENSMUSG00000028672 MGI:96158 protein coding gene 3-hydroxy-3-methylglutaryl-Coenzyme A lyase
4 gene 135.963681 135.968178 positive MGI_C57BL6J_1921496 Gale NCBI_Gene:74246,ENSEMBL:ENSMUSG00000028671 MGI:1921496 protein coding gene galactose-4-epimerase, UDP
4 gene 135.968224 135.972626 negative MGI_C57BL6J_1347000 Lypla2 NCBI_Gene:26394,ENSEMBL:ENSMUSG00000028670 MGI:1347000 protein coding gene lysophospholipase 2
4 gene 135.975460 135.987264 negative MGI_C57BL6J_1913443 Pithd1 NCBI_Gene:66193,ENSEMBL:ENSMUSG00000028669 MGI:1913443 protein coding gene PITH (C-terminal proteasome-interacting domain of thioredoxin-like) domain containing 1
4 pseudogene 135.997508 135.997902 positive MGI_C57BL6J_3649722 Gm13007 NCBI_Gene:669445,ENSEMBL:ENSMUSG00000083852 MGI:3649722 pseudogene predicted gene 13007
4 gene 136.003368 136.021763 negative MGI_C57BL6J_1351315 Eloa NCBI_Gene:27224,ENSEMBL:ENSMUSG00000028668 MGI:1351315 protein coding gene elongin A
4 gene 136.003566 136.010937 positive MGI_C57BL6J_3702670 Gm13008 ENSEMBL:ENSMUSG00000085714 MGI:3702670 lncRNA gene predicted gene 13008
4 gene 136.018071 136.018486 negative MGI_C57BL6J_5454139 Gm24362 ENSEMBL:ENSMUSG00000097995 MGI:5454139 lncRNA gene predicted gene, 24362
4 gene 136.028265 136.053428 negative MGI_C57BL6J_1914275 Rpl11 NCBI_Gene:67025,ENSEMBL:ENSMUSG00000059291 MGI:1914275 protein coding gene ribosomal protein L11
4 pseudogene 136.074513 136.074972 negative MGI_C57BL6J_3651086 Gm13009 ENSEMBL:ENSMUSG00000082877 MGI:3651086 pseudogene predicted gene 13009
4 gene 136.137496 136.137598 positive MGI_C57BL6J_5455778 Gm26001 ENSEMBL:ENSMUSG00000088614 MGI:5455778 snRNA gene predicted gene, 26001
4 gene 136.138595 136.143352 negative MGI_C57BL6J_5625214 Gm42329 NCBI_Gene:105247187 MGI:5625214 lncRNA gene predicted gene, 42329
4 gene 136.143497 136.145755 positive MGI_C57BL6J_96398 Id3 NCBI_Gene:15903,ENSEMBL:ENSMUSG00000007872 MGI:96398 protein coding gene inhibitor of DNA binding 3
4 gene 136.172274 136.196057 positive MGI_C57BL6J_1096341 E2f2 NCBI_Gene:242705,ENSEMBL:ENSMUSG00000018983 MGI:1096341 protein coding gene E2F transcription factor 2
4 gene 136.206349 136.246577 positive MGI_C57BL6J_2684986 Asap3 NCBI_Gene:230837,ENSEMBL:ENSMUSG00000036995 MGI:2684986 protein coding gene ArfGAP with SH3 domain, ankyrin repeat and PH domain 3
4 gene 136.214469 136.216551 positive MGI_C57BL6J_2441962 D230019A03Rik NA NA unclassified gene RIKEN cDNA D230019A03 gene
4 gene 136.247729 136.274903 positive MGI_C57BL6J_1196908 Tcea3 NCBI_Gene:21401,ENSEMBL:ENSMUSG00000001604 MGI:1196908 protein coding gene transcription elongation factor A (SII), 3
4 gene 136.284168 136.293942 positive MGI_C57BL6J_99192 Zfp46 NCBI_Gene:22704,ENSEMBL:ENSMUSG00000051351 MGI:99192 protein coding gene zinc finger protein 46
4 pseudogene 136.307364 136.307886 negative MGI_C57BL6J_3650319 Gm13013 ENSEMBL:ENSMUSG00000081330 MGI:3650319 pseudogene predicted gene 13013
4 gene 136.310942 136.359447 positive MGI_C57BL6J_1891692 Hnrnpr NCBI_Gene:74326,ENSEMBL:ENSMUSG00000066037 MGI:1891692 protein coding gene heterogeneous nuclear ribonucleoprotein R
4 gene 136.347847 136.349441 negative MGI_C57BL6J_5504137 Gm27022 ENSEMBL:ENSMUSG00000098155 MGI:5504137 lncRNA gene predicted gene, 27022
4 gene 136.350334 136.359447 positive MGI_C57BL6J_1918848 9130020K20Rik NCBI_Gene:105247188 MGI:1918848 lncRNA gene RIKEN cDNA 9130020K20 gene
4 gene 136.355774 136.359440 positive MGI_C57BL6J_4937022 Gm17388 NA NA lncRNA gene predicted gene%2c 17388
4 gene 136.387466 136.388993 positive MGI_C57BL6J_5590454 Gm31295 NCBI_Gene:102633481 MGI:5590454 lncRNA gene predicted gene, 31295
4 gene 136.423522 136.444405 positive MGI_C57BL6J_96276 Htr1d NCBI_Gene:15552,ENSEMBL:ENSMUSG00000070687 MGI:96276 protein coding gene 5-hydroxytryptamine (serotonin) receptor 1D
4 gene 136.462250 136.463980 positive MGI_C57BL6J_2443447 6030445D17Rik ENSEMBL:ENSMUSG00000066178 MGI:2443447 protein coding gene RIKEN cDNA 6030445D17 gene
4 gene 136.469749 136.554780 positive MGI_C57BL6J_107629 Luzp1 NCBI_Gene:269593,ENSEMBL:ENSMUSG00000001089 MGI:107629 protein coding gene leucine zipper protein 1
4 gene 136.550533 136.602790 negative MGI_C57BL6J_1196256 Kdm1a NCBI_Gene:99982,ENSEMBL:ENSMUSG00000036940 MGI:1196256 protein coding gene lysine (K)-specific demethylase 1A
4 pseudogene 136.584172 136.584660 negative MGI_C57BL6J_3649751 Gm12987 ENSEMBL:ENSMUSG00000082711 MGI:3649751 pseudogene predicted gene 12987
4 gene 136.606944 136.613278 positive MGI_C57BL6J_1914913 Tex46 NCBI_Gene:67663,ENSEMBL:ENSMUSG00000036921 MGI:1914913 protein coding gene testis expressed 46
4 pseudogene 136.608819 136.609864 negative MGI_C57BL6J_3651584 Gm12986 NCBI_Gene:433770,ENSEMBL:ENSMUSG00000083054 MGI:3651584 pseudogene predicted gene 12986
4 gene 136.609806 136.609864 negative MGI_C57BL6J_5451957 Gm22180 ENSEMBL:ENSMUSG00000092747 MGI:5451957 miRNA gene predicted gene, 22180
4 gene 136.622621 136.639829 positive MGI_C57BL6J_2448566 Lactbl1 NCBI_Gene:242707,ENSEMBL:ENSMUSG00000070683 MGI:2448566 protein coding gene lactamase, beta-like 1
4 gene 136.639582 136.642068 positive MGI_C57BL6J_5610811 Gm37583 ENSEMBL:ENSMUSG00000103119 MGI:5610811 unclassified gene predicted gene, 37583
4 gene 136.647536 136.836012 negative MGI_C57BL6J_99611 Ephb2 NCBI_Gene:13844,ENSEMBL:ENSMUSG00000028664 MGI:99611 protein coding gene Eph receptor B2
4 gene 136.836026 136.842074 positive MGI_C57BL6J_5590695 Gm31536 NCBI_Gene:102633796 MGI:5590695 lncRNA gene predicted gene, 31536
4 gene 136.880129 136.886187 negative MGI_C57BL6J_88224 C1qb NCBI_Gene:12260,ENSEMBL:ENSMUSG00000036905 MGI:88224 protein coding gene complement component 1, q subcomponent, beta polypeptide
4 gene 136.889802 136.893065 negative MGI_C57BL6J_88225 C1qc NCBI_Gene:12262,ENSEMBL:ENSMUSG00000036896 MGI:88225 protein coding gene complement component 1, q subcomponent, C chain
4 gene 136.895916 136.898844 negative MGI_C57BL6J_88223 C1qa NCBI_Gene:12259,ENSEMBL:ENSMUSG00000036887 MGI:88223 protein coding gene complement component 1, q subcomponent, alpha polypeptide
4 gene 136.929419 136.956816 negative MGI_C57BL6J_109378 Epha8 NCBI_Gene:13842,ENSEMBL:ENSMUSG00000028661 MGI:109378 protein coding gene Eph receptor A8
4 gene 136.979732 137.049444 negative MGI_C57BL6J_2682254 Zbtb40 NCBI_Gene:230848,ENSEMBL:ENSMUSG00000060862 MGI:2682254 protein coding gene zinc finger and BTB domain containing 40
4 gene 137.025684 137.025812 positive MGI_C57BL6J_5453611 Gm23834 ENSEMBL:ENSMUSG00000077624 MGI:5453611 snoRNA gene predicted gene, 23834
4 gene 137.076595 137.095101 positive MGI_C57BL6J_5590807 Gm31648 NCBI_Gene:102633949 MGI:5590807 lncRNA gene predicted gene, 31648
4 gene 137.116705 137.118255 negative MGI_C57BL6J_3702655 Gm13001 NCBI_Gene:102634021,ENSEMBL:ENSMUSG00000087417 MGI:3702655 lncRNA gene predicted gene 13001
4 gene 137.116709 137.117582 negative MGI_C57BL6J_1921513 1700037C06Rik ENSEMBL:ENSMUSG00000085542 MGI:1921513 lncRNA gene RIKEN cDNA 1700037C06 gene
4 gene 137.139496 137.142458 negative MGI_C57BL6J_5590921 Gm31762 NCBI_Gene:102634099 MGI:5590921 lncRNA gene predicted gene, 31762
4 gene 137.159082 137.165066 negative MGI_C57BL6J_3650099 Gm13003 NCBI_Gene:100503595,ENSEMBL:ENSMUSG00000085833 MGI:3650099 lncRNA gene predicted gene 13003
4 gene 137.171297 137.178084 negative MGI_C57BL6J_5826509 Gm46872 NCBI_Gene:108168981 MGI:5826509 lncRNA gene predicted gene, 46872
4 gene 137.183987 137.184062 positive MGI_C57BL6J_5455176 Gm25399 ENSEMBL:ENSMUSG00000093294 MGI:5455176 miRNA gene predicted gene, 25399
4 gene 137.184065 137.184140 positive MGI_C57BL6J_5453040 Gm23263 ENSEMBL:ENSMUSG00000092848 MGI:5453040 miRNA gene predicted gene, 23263
4 gene 137.184081 137.252761 negative MGI_C57BL6J_5590979 Gm31820 NCBI_Gene:102634171 MGI:5590979 lncRNA gene predicted gene, 31820
4 pseudogene 137.218996 137.220438 negative MGI_C57BL6J_3650102 Gm13005 NCBI_Gene:100047000,ENSEMBL:ENSMUSG00000080806 MGI:3650102 pseudogene predicted gene 13005
4 pseudogene 137.222641 137.223322 negative MGI_C57BL6J_3650101 Gm13002 ENSEMBL:ENSMUSG00000082149 MGI:3650101 pseudogene predicted gene 13002
4 gene 137.277489 137.299726 positive MGI_C57BL6J_98957 Wnt4 NCBI_Gene:22417,ENSEMBL:ENSMUSG00000036856 MGI:98957 protein coding gene wingless-type MMTV integration site family, member 4
4 gene 137.319696 137.357759 negative MGI_C57BL6J_106211 Cdc42 NCBI_Gene:12540,ENSEMBL:ENSMUSG00000006699 MGI:106211 protein coding gene cell division cycle 42
4 gene 137.325559 137.325614 positive MGI_C57BL6J_5455549 Gm25772 ENSEMBL:ENSMUSG00000089199 MGI:5455549 snRNA gene predicted gene, 25772
4 gene 137.336387 137.340095 negative MGI_C57BL6J_2441797 A430061O12Rik NA NA unclassified gene RIKEN cDNA A430061O12 gene
4 gene 137.387266 137.388382 negative MGI_C57BL6J_1917225 2810405F17Rik ENSEMBL:ENSMUSG00000101493 MGI:1917225 lncRNA gene RIKEN cDNA 2810405F17 gene
4 pseudogene 137.395299 137.395709 positive MGI_C57BL6J_3650100 Rpl31-ps10 NCBI_Gene:665533,ENSEMBL:ENSMUSG00000070667 MGI:3650100 pseudogene ribosomal protein L31, pseudogene 10
4 gene 137.401554 137.409791 negative MGI_C57BL6J_3651647 Cela3a NCBI_Gene:242711,ENSEMBL:ENSMUSG00000078520 MGI:3651647 protein coding gene chymotrypsin-like elastase family, member 3A
4 gene 137.420999 137.430540 negative MGI_C57BL6J_1915118 Cela3b NCBI_Gene:67868,ENSEMBL:ENSMUSG00000023433 MGI:1915118 protein coding gene chymotrypsin-like elastase family, member 3B
4 gene 137.436579 137.467142 negative MGI_C57BL6J_3651180 Gm13010 NCBI_Gene:105247191,ENSEMBL:ENSMUSG00000086845 MGI:3651180 lncRNA gene predicted gene 13010
4 gene 137.453284 137.455461 positive MGI_C57BL6J_1916630 1700013G24Rik NCBI_Gene:69380,ENSEMBL:ENSMUSG00000041399 MGI:1916630 protein coding gene RIKEN cDNA 1700013G24 gene
4 gene 137.468764 137.570630 positive MGI_C57BL6J_96257 Hspg2 NCBI_Gene:15530,ENSEMBL:ENSMUSG00000028763 MGI:96257 protein coding gene perlecan (heparan sulfate proteoglycan 2)
4 gene 137.538286 137.538370 positive MGI_C57BL6J_5530988 Mir7018 miRBase:MI0022867,NCBI_Gene:102465616,ENSEMBL:ENSMUSG00000099134 MGI:5530988 miRNA gene microRNA 7018
4 gene 137.570714 137.582385 negative MGI_C57BL6J_3588210 Ldlrad2 NCBI_Gene:435811,ENSEMBL:ENSMUSG00000094035 MGI:3588210 protein coding gene low density lipoprotein receptor class A domain containing 2
4 gene 137.593755 137.658537 positive MGI_C57BL6J_2158502 Usp48 NCBI_Gene:170707,ENSEMBL:ENSMUSG00000043411 MGI:2158502 protein coding gene ubiquitin specific peptidase 48
4 gene 137.664710 137.729861 positive MGI_C57BL6J_109338 Rap1gap NCBI_Gene:110351,ENSEMBL:ENSMUSG00000041351 MGI:109338 protein coding gene Rap1 GTPase-activating protein
4 gene 137.696978 137.707377 negative MGI_C57BL6J_1917058 Rap1gapos NCBI_Gene:69808,ENSEMBL:ENSMUSG00000087476 MGI:1917058 antisense lncRNA gene RAP1 GTPase activating protein, opposite strand
4 gene 137.741731 137.796384 negative MGI_C57BL6J_87983 Alpl NCBI_Gene:11647,ENSEMBL:ENSMUSG00000028766 MGI:87983 protein coding gene alkaline phosphatase, liver/bone/kidney
4 gene 137.806270 137.811976 negative MGI_C57BL6J_5591238 Gm32079 NCBI_Gene:102634516 MGI:5591238 lncRNA gene predicted gene, 32079
4 gene 137.862212 137.965229 positive MGI_C57BL6J_1101357 Ece1 NCBI_Gene:230857,ENSEMBL:ENSMUSG00000057530 MGI:1101357 protein coding gene endothelin converting enzyme 1
4 gene 137.882037 137.883937 negative MGI_C57BL6J_3652270 Gm13012 NCBI_Gene:102634683,ENSEMBL:ENSMUSG00000085823 MGI:3652270 lncRNA gene predicted gene 13012
4 gene 137.915402 137.915477 negative MGI_C57BL6J_1921862 4833410I11Rik NA NA unclassified gene RIKEN cDNA 4833410I11 gene
4 gene 137.991842 137.992251 positive MGI_C57BL6J_3035105 BE691133 NA NA unclassified gene expressed sequence BE691133
4 gene 137.993013 138.208508 positive MGI_C57BL6J_1923935 Eif4g3 NCBI_Gene:230861,ENSEMBL:ENSMUSG00000028760 MGI:1923935 protein coding gene eukaryotic translation initiation factor 4 gamma, 3
4 gene 137.994151 138.027903 positive MGI_C57BL6J_5591553 Gm32394 NCBI_Gene:102634927 MGI:5591553 lncRNA gene predicted gene, 32394
4 gene 138.014004 138.018383 positive MGI_C57BL6J_3611235 8030494B02Rik NA NA unclassified non-coding RNA gene Riken cDNA 8030494B02 gene
4 gene 138.137580 138.138518 negative MGI_C57BL6J_1920813 1700095J12Rik NCBI_Gene:73563,ENSEMBL:ENSMUSG00000084804 MGI:1920813 lncRNA gene RIKEN cDNA 1700095J12 gene
4 gene 138.163209 138.163292 positive MGI_C57BL6J_5531049 Mir6399 miRBase:MI0021935,NCBI_Gene:102466907,ENSEMBL:ENSMUSG00000098513 MGI:5531049 miRNA gene microRNA 6399
4 gene 138.215714 138.216189 positive MGI_C57BL6J_1916844 2310026L22Rik ENSEMBL:ENSMUSG00000078519 MGI:1916844 lncRNA gene RIKEN cDNA 2310026L22 gene
4 gene 138.216296 138.244683 positive MGI_C57BL6J_109369 Hp1bp3 NCBI_Gene:15441,ENSEMBL:ENSMUSG00000028759 MGI:109369 protein coding gene heterochromatin protein 1, binding protein 3
4 gene 138.250403 138.261332 positive MGI_C57BL6J_2446215 Sh2d5 NCBI_Gene:230863,ENSEMBL:ENSMUSG00000045349 MGI:2446215 protein coding gene SH2 domain containing 5
4 gene 138.250435 138.301973 positive MGI_C57BL6J_1098229 Kif17 NCBI_Gene:16559,ENSEMBL:ENSMUSG00000028758 MGI:1098229 protein coding gene kinesin family member 17
4 gene 138.304730 138.312628 positive MGI_C57BL6J_1194508 Ddost NCBI_Gene:13200,ENSEMBL:ENSMUSG00000028757 MGI:1194508 protein coding gene dolichyl-di-phosphooligosaccharide-protein glycotransferase
4 gene 138.313409 138.326307 negative MGI_C57BL6J_1916193 Pink1 NCBI_Gene:68943,ENSEMBL:ENSMUSG00000028756 MGI:1916193 protein coding gene PTEN induced putative kinase 1
4 gene 138.316132 138.316200 negative MGI_C57BL6J_5531329 Mir7019 miRBase:MI0022868,NCBI_Gene:102466788,ENSEMBL:ENSMUSG00000099200 MGI:5531329 miRNA gene microRNA 7019
4 gene 138.325980 138.326089 negative MGI_C57BL6J_5531028 Gm27646 ENSEMBL:ENSMUSG00000098364 MGI:5531028 miRNA gene predicted gene, 27646
4 gene 138.338424 138.368311 negative MGI_C57BL6J_1919519 Cda NCBI_Gene:72269,ENSEMBL:ENSMUSG00000028755 MGI:1919519 protein coding gene cytidine deaminase
4 gene 138.394092 138.396528 negative MGI_C57BL6J_3651622 Fam43b NCBI_Gene:625638,ENSEMBL:ENSMUSG00000078235 MGI:3651622 protein coding gene family with sequence similarity 43, member B
4 gene 138.395198 138.397714 positive MGI_C57BL6J_1931024 AB041806 ENSEMBL:ENSMUSG00000046109 MGI:1931024 lncRNA gene hypothetical protein, MNCb-2457
4 pseudogene 138.425720 138.426042 positive MGI_C57BL6J_3649580 Rpl38-ps1 NCBI_Gene:625646,ENSEMBL:ENSMUSG00000083326 MGI:3649580 pseudogene ribosomal protein L38, pseudogene 1
4 gene 138.434659 138.442265 positive MGI_C57BL6J_1915600 Mul1 NCBI_Gene:68350,ENSEMBL:ENSMUSG00000041241 MGI:1915600 protein coding gene mitochondrial ubiquitin ligase activator of NFKB 1
4 gene 138.454314 138.460126 positive MGI_C57BL6J_1913509 Camk2n1 NCBI_Gene:66259,ENSEMBL:ENSMUSG00000046447 MGI:1913509 protein coding gene calcium/calmodulin-dependent protein kinase II inhibitor 1
4 gene 138.497634 138.528513 positive MGI_C57BL6J_5591708 Gm32549 NCBI_Gene:102635131 MGI:5591708 lncRNA gene predicted gene, 32549
4 gene 138.564229 138.635938 negative MGI_C57BL6J_1922968 Vwa5b1 NCBI_Gene:75718,ENSEMBL:ENSMUSG00000028753 MGI:1922968 protein coding gene von Willebrand factor A domain containing 5B1
4 gene 138.587624 138.587729 negative MGI_C57BL6J_5452738 Gm22961 ENSEMBL:ENSMUSG00000088589 MGI:5452738 snRNA gene predicted gene, 22961
4 gene 138.638978 138.657636 positive MGI_C57BL6J_5591821 Gm32662 NCBI_Gene:102635281 MGI:5591821 lncRNA gene predicted gene, 32662
4 gene 138.677510 138.711737 positive MGI_C57BL6J_5591929 Gm32770 NCBI_Gene:102635431 MGI:5591929 lncRNA gene predicted gene, 32770
4 gene 138.677774 138.678156 positive MGI_C57BL6J_1914908 4930563F15Rik NA NA unclassified gene RIKEN cDNA 4930563F15 gene
4 gene 138.709837 138.738438 negative MGI_C57BL6J_2443123 Ubxn10 NCBI_Gene:212190,ENSEMBL:ENSMUSG00000043621 MGI:2443123 protein coding gene UBX domain protein 10
4 gene 138.724792 138.746132 positive MGI_C57BL6J_106638 Pla2g2c NCBI_Gene:18781,ENSEMBL:ENSMUSG00000028750 MGI:106638 protein coding gene phospholipase A2, group IIC
4 gene 138.750533 138.757626 negative MGI_C57BL6J_1349661 Pla2g2f NCBI_Gene:26971,ENSEMBL:ENSMUSG00000028749 MGI:1349661 protein coding gene phospholipase A2, group IIF
4 gene 138.761374 138.769700 negative MGI_C57BL6J_5625217 Gm42332 NCBI_Gene:105247193 MGI:5625217 lncRNA gene predicted gene, 42332
4 gene 138.772493 138.780240 negative MGI_C57BL6J_5592030 Gm32871 NCBI_Gene:102635577 MGI:5592030 lncRNA gene predicted gene, 32871
4 gene 138.775735 138.782143 positive MGI_C57BL6J_1341796 Pla2g2d NCBI_Gene:18782,ENSEMBL:ENSMUSG00000041202 MGI:1341796 protein coding gene phospholipase A2, group IID
4 gene 138.799244 138.863482 negative MGI_C57BL6J_101899 Pla2g5 NCBI_Gene:18784,ENSEMBL:ENSMUSG00000041193 MGI:101899 protein coding gene phospholipase A2, group V
4 gene 138.827376 138.827476 negative MGI_C57BL6J_5455057 Gm25280 ENSEMBL:ENSMUSG00000087894 MGI:5455057 snRNA gene predicted gene, 25280
4 pseudogene 138.831857 138.835189 positive MGI_C57BL6J_104642 Pla2g2a NCBI_Gene:18780,ENSEMBL:ENSMUSG00000058908 MGI:104642 polymorphic pseudogene phospholipase A2, group IIA (platelets, synovial fluid)
4 gene 138.863507 138.868626 positive MGI_C57BL6J_5592089 Gm32930 NCBI_Gene:102635643 MGI:5592089 lncRNA gene predicted gene, 32930
4 gene 138.870992 138.873964 negative MGI_C57BL6J_3651765 Gm13030 NCBI_Gene:105734733,ENSEMBL:ENSMUSG00000078518 MGI:3651765 protein coding gene predicted gene 13030
4 gene 138.877911 138.882817 positive MGI_C57BL6J_1349660 Pla2g2e NCBI_Gene:26970,ENSEMBL:ENSMUSG00000028751 MGI:1349660 protein coding gene phospholipase A2, group IIE
4 gene 138.891063 138.914018 negative MGI_C57BL6J_1920412 Otud3 NCBI_Gene:73162,ENSEMBL:ENSMUSG00000041161 MGI:1920412 protein coding gene OTU domain containing 3
4 pseudogene 138.935213 138.935714 negative MGI_C57BL6J_5010282 Gm18097 NCBI_Gene:100416403 MGI:5010282 pseudogene predicted gene, 18097
4 gene 138.936447 138.938608 negative MGI_C57BL6J_5592170 Gm33011 NCBI_Gene:102635752 MGI:5592170 lncRNA gene predicted gene, 33011
4 gene 138.961910 138.964681 negative MGI_C57BL6J_5625218 Gm42333 NCBI_Gene:105247194 MGI:5625218 lncRNA gene predicted gene, 42333
4 gene 138.967112 138.968366 positive MGI_C57BL6J_1914075 Rnf186 NCBI_Gene:66825,ENSEMBL:ENSMUSG00000070661 MGI:1914075 protein coding gene ring finger protein 186
4 gene 138.972106 139.059173 positive MGI_C57BL6J_1924306 Tmco4 NCBI_Gene:77056,ENSEMBL:ENSMUSG00000041143 MGI:1924306 protein coding gene transmembrane and coiled-coil domains 4
4 gene 139.003191 139.019566 negative MGI_C57BL6J_5592373 Gm33214 NCBI_Gene:102636025 MGI:5592373 lncRNA gene predicted gene, 33214
4 gene 139.059705 139.075570 negative MGI_C57BL6J_1196627 Htr6 NCBI_Gene:15565,ENSEMBL:ENSMUSG00000028747 MGI:1196627 protein coding gene 5-hydroxytryptamine (serotonin) receptor 6
4 gene 139.074942 139.077215 positive MGI_C57BL6J_5791369 Gm45533 NCBI_Gene:108168960,ENSEMBL:ENSMUSG00000110296 MGI:5791369 lncRNA gene predicted gene 45533
4 gene 139.082284 139.092993 negative MGI_C57BL6J_104591 Nbl1 NCBI_Gene:17965,ENSEMBL:ENSMUSG00000041120 MGI:104591 protein coding gene NBL1, DAN family BMP antagonist
4 gene 139.101814 139.131113 negative MGI_C57BL6J_1913628 Micos10 NCBI_Gene:433771,ENSEMBL:ENSMUSG00000050608 MGI:1913628 protein coding gene mitochondrial contact site and cristae organizing system subunit 10
4 gene 139.134109 139.165291 negative MGI_C57BL6J_5592463 Gm33304 NCBI_Gene:102636159 MGI:5592463 lncRNA gene predicted gene, 33304
4 pseudogene 139.150197 139.150805 positive MGI_C57BL6J_1935164 Hspe1-ps4 NCBI_Gene:93751,ENSEMBL:ENSMUSG00000083238 MGI:1935164 pseudogene heat shock protein 1 (chaperonin 10), pseudogene 4
4 gene 139.175405 139.180655 negative MGI_C57BL6J_3650322 Gm16287 NCBI_Gene:100038595,ENSEMBL:ENSMUSG00000073739 MGI:3650322 lncRNA gene predicted gene 16287
4 gene 139.192234 139.192680 negative MGI_C57BL6J_1925704 9530077C14Rik NA NA unclassified gene RIKEN cDNA 9530077C14 gene
4 gene 139.192899 139.291820 positive MGI_C57BL6J_104652 Capzb NCBI_Gene:12345,ENSEMBL:ENSMUSG00000028745 MGI:104652 protein coding gene capping protein (actin filament) muscle Z-line, beta
4 gene 139.294029 139.310713 negative MGI_C57BL6J_2384837 Pqlc2 NCBI_Gene:212555,ENSEMBL:ENSMUSG00000028744 MGI:2384837 protein coding gene PQ loop repeat containing 2
4 gene 139.310701 139.318786 positive MGI_C57BL6J_107796 Akr7a5 NCBI_Gene:110198,ENSEMBL:ENSMUSG00000028743 MGI:107796 protein coding gene aldo-keto reductase family 7, member A5 (aflatoxin aldehyde reductase)
4 gene 139.338206 139.338265 positive MGI_C57BL6J_5455509 Gm25732 ENSEMBL:ENSMUSG00000092909 MGI:5455509 miRNA gene predicted gene, 25732
4 gene 139.338304 139.338360 positive MGI_C57BL6J_5454022 Gm24245 ENSEMBL:ENSMUSG00000087943 MGI:5454022 miRNA gene predicted gene, 24245
4 pseudogene 139.342183 139.343333 positive MGI_C57BL6J_3652310 Gm13019 ENSEMBL:ENSMUSG00000083404 MGI:3652310 pseudogene predicted gene 13019
4 pseudogene 139.344392 139.346315 negative MGI_C57BL6J_1100505 Ccnd3-ps NCBI_Gene:626000,ENSEMBL:ENSMUSG00000080708 MGI:1100505 pseudogene cyclin D3, pseudogene
4 gene 139.347435 139.352576 negative MGI_C57BL6J_1917152 Mrto4 NCBI_Gene:69902,ENSEMBL:ENSMUSG00000028741 MGI:1917152 protein coding gene mRNA turnover 4, ribosome maturation factor
4 gene 139.352587 139.378735 positive MGI_C57BL6J_2443696 Emc1 NCBI_Gene:230866,ENSEMBL:ENSMUSG00000078517 MGI:2443696 protein coding gene ER membrane protein complex subunit 1
4 gene 139.352609 139.489588 positive MGI_C57BL6J_1916366 Ubr4 NCBI_Gene:69116,ENSEMBL:ENSMUSG00000066036 MGI:1916366 protein coding gene ubiquitin protein ligase E3 component n-recognin 4
4 gene 139.376549 139.380379 negative MGI_C57BL6J_1919807 2700016F22Rik ENSEMBL:ENSMUSG00000097731 MGI:1919807 lncRNA gene RIKEN cDNA 2700016F22 gene
4 gene 139.430506 139.430577 negative MGI_C57BL6J_4414084 n-TVaac1 NCBI_Gene:102467443 MGI:4414084 tRNA gene nuclear encoded tRNA valine 1 (anticodon AAC)
4 gene 139.530548 139.620382 positive MGI_C57BL6J_2140675 Iffo2 NCBI_Gene:212632,ENSEMBL:ENSMUSG00000041025 MGI:2140675 protein coding gene intermediate filament family orphan 2
4 gene 139.588876 139.588977 negative MGI_C57BL6J_5455348 Gm25571 ENSEMBL:ENSMUSG00000094359 MGI:5455348 miRNA gene predicted gene, 25571
4 gene 139.603186 139.662691 positive MGI_C57BL6J_5439438 Gm21969 ENSEMBL:ENSMUSG00000094439 MGI:5439438 protein coding gene predicted gene 21969
4 gene 139.622866 139.649691 positive MGI_C57BL6J_2443883 Aldh4a1 NCBI_Gene:212647,ENSEMBL:ENSMUSG00000028737 MGI:2443883 protein coding gene aldehyde dehydrogenase 4 family, member A1
4 gene 139.644042 139.644111 positive MGI_C57BL6J_5531141 Mir7020 miRBase:MI0022869,NCBI_Gene:102465617,ENSEMBL:ENSMUSG00000098569 MGI:5531141 miRNA gene microRNA 7020
4 gene 139.653538 139.670280 positive MGI_C57BL6J_1933546 Tas1r2 NCBI_Gene:83770,ENSEMBL:ENSMUSG00000028738 MGI:1933546 protein coding gene taste receptor, type 1, member 2
4 gene 139.734957 139.735657 positive MGI_C57BL6J_5625219 Gm42334 NCBI_Gene:105247195 MGI:5625219 lncRNA gene predicted gene, 42334
4 gene 139.737059 139.833528 negative MGI_C57BL6J_97491 Pax7 NCBI_Gene:18509,ENSEMBL:ENSMUSG00000028736 MGI:97491 protein coding gene paired box 7
4 gene 139.833061 139.852920 positive MGI_C57BL6J_5826510 Gm46873 NCBI_Gene:108168982 MGI:5826510 lncRNA gene predicted gene, 46873
4 gene 139.910464 139.934390 positive MGI_C57BL6J_2686513 Gm1667 NCBI_Gene:102636380,ENSEMBL:ENSMUSG00000087646 MGI:2686513 lncRNA gene predicted gene 1667
4 gene 139.923349 139.933170 positive MGI_C57BL6J_3651504 Gm13028 ENSEMBL:ENSMUSG00000087628 MGI:3651504 lncRNA gene predicted gene 13028
4 gene 139.926111 139.943519 negative MGI_C57BL6J_1918485 4933427I22Rik NCBI_Gene:71235,ENSEMBL:ENSMUSG00000085928 MGI:1918485 lncRNA gene RIKEN cDNA 4933427I22 gene
4 gene 139.960220 139.968026 negative MGI_C57BL6J_2444612 Klhdc7a NCBI_Gene:242721,ENSEMBL:ENSMUSG00000078234 MGI:2444612 protein coding gene kelch domain containing 7A
4 gene 139.967526 139.967620 negative MGI_C57BL6J_4358926 Mir2139 miRBase:MI0010752,NCBI_Gene:100316727,ENSEMBL:ENSMUSG00000089294 MGI:4358926 miRNA gene microRNA 2139
4 gene 140.026846 140.246852 negative MGI_C57BL6J_2681842 Igsf21 NCBI_Gene:230868,ENSEMBL:ENSMUSG00000040972 MGI:2681842 protein coding gene immunoglobulin superfamily, member 21
4 gene 140.108627 140.144988 positive MGI_C57BL6J_3651764 Gm13029 NCBI_Gene:102636673,ENSEMBL:ENSMUSG00000086164 MGI:3651764 lncRNA gene predicted gene 13029
4 gene 140.131877 140.133351 positive MGI_C57BL6J_3651912 Gm13027 ENSEMBL:ENSMUSG00000085968 MGI:3651912 lncRNA gene predicted gene 13027
4 gene 140.218487 140.222459 positive MGI_C57BL6J_5592701 Gm33542 NCBI_Gene:102636490 MGI:5592701 lncRNA gene predicted gene, 33542
4 gene 140.320656 140.323302 negative MGI_C57BL6J_3642724 Gm9867 ENSEMBL:ENSMUSG00000103107 MGI:3642724 lncRNA gene predicted gene 9867
4 gene 140.323445 140.330523 positive MGI_C57BL6J_5593054 Gm33895 NCBI_Gene:102636971 MGI:5593054 lncRNA gene predicted gene, 33895
4 gene 140.355406 140.361939 positive MGI_C57BL6J_5593233 Gm34074 NCBI_Gene:102637201 MGI:5593233 lncRNA gene predicted gene, 34074
4 gene 140.380467 140.386394 positive MGI_C57BL6J_3650527 Gm13016 NCBI_Gene:329970,ENSEMBL:ENSMUSG00000087084 MGI:3650527 lncRNA gene predicted gene 13016
4 gene 140.390432 140.396917 positive MGI_C57BL6J_3650528 Gm13017 NCBI_Gene:102637278,ENSEMBL:ENSMUSG00000086960 MGI:3650528 lncRNA gene predicted gene 13017
4 gene 140.422524 140.431931 positive MGI_C57BL6J_3649637 Gm13021 NCBI_Gene:102637389,ENSEMBL:ENSMUSG00000086437 MGI:3649637 lncRNA gene predicted gene 13021
4 gene 140.437963 140.461291 positive MGI_C57BL6J_3650881 Gm13026 ENSEMBL:ENSMUSG00000085047 MGI:3650881 lncRNA gene predicted gene 13026
4 pseudogene 140.445846 140.446164 negative MGI_C57BL6J_6324716 Gm50453 ENSEMBL:ENSMUSG00000118416 MGI:6324716 pseudogene predicted gene, 50453
4 gene 140.514485 140.666012 negative MGI_C57BL6J_1920004 Arhgef10l NCBI_Gene:72754,ENSEMBL:ENSMUSG00000040964 MGI:1920004 protein coding gene Rho guanine nucleotide exchange factor (GEF) 10-like
4 gene 140.605107 140.606567 positive MGI_C57BL6J_5625220 Gm42335 NCBI_Gene:105247196 MGI:5625220 lncRNA gene predicted gene, 42335
4 gene 140.679745 140.686291 positive MGI_C57BL6J_3650883 Gm13025 NCBI_Gene:102637546,ENSEMBL:ENSMUSG00000086159 MGI:3650883 lncRNA gene predicted gene 13025
4 gene 140.692697 140.692792 positive MGI_C57BL6J_5452822 Gm23045 ENSEMBL:ENSMUSG00000095878 MGI:5452822 miRNA gene predicted gene, 23045
4 gene 140.700541 140.723220 positive MGI_C57BL6J_1919784 Rcc2 NCBI_Gene:108911,ENSEMBL:ENSMUSG00000040945 MGI:1919784 protein coding gene regulator of chromosome condensation 2
4 gene 140.717043 140.717106 positive MGI_C57BL6J_5455728 Gm25951 ENSEMBL:ENSMUSG00000093071 MGI:5455728 miRNA gene predicted gene, 25951
4 gene 140.727355 140.742643 negative MGI_C57BL6J_2655198 Padi6 NCBI_Gene:242726,ENSEMBL:ENSMUSG00000040935 MGI:2655198 protein coding gene peptidyl arginine deiminase, type VI
4 gene 140.745508 140.774239 negative MGI_C57BL6J_1338898 Padi4 NCBI_Gene:18602,ENSEMBL:ENSMUSG00000025330 MGI:1338898 protein coding gene peptidyl arginine deiminase, type IV
4 gene 140.785365 140.810648 negative MGI_C57BL6J_1338891 Padi3 NCBI_Gene:18601,ENSEMBL:ENSMUSG00000025328 MGI:1338891 protein coding gene peptidyl arginine deiminase, type III
4 gene 140.810993 140.817511 positive MGI_C57BL6J_3702685 Gm13032 NCBI_Gene:100049161,ENSEMBL:ENSMUSG00000085918 MGI:3702685 lncRNA gene predicted gene 13032
4 gene 140.812981 140.845778 negative MGI_C57BL6J_1338893 Padi1 NCBI_Gene:18599,ENSEMBL:ENSMUSG00000025329 MGI:1338893 protein coding gene peptidyl arginine deiminase, type I
4 gene 140.872693 140.878057 positive MGI_C57BL6J_1922378 4930515B02Rik NCBI_Gene:75128,ENSEMBL:ENSMUSG00000087045 MGI:1922378 lncRNA gene RIKEN cDNA 4930515B02 gene
4 gene 140.906337 140.952586 positive MGI_C57BL6J_1338892 Padi2 NCBI_Gene:18600,ENSEMBL:ENSMUSG00000028927 MGI:1338892 protein coding gene peptidyl arginine deiminase, type II
4 gene 140.908974 140.910338 negative MGI_C57BL6J_5826356 Gm46719 NCBI_Gene:108168688 MGI:5826356 lncRNA gene predicted gene, 46719
4 gene 140.918684 140.918799 positive MGI_C57BL6J_5456003 Gm26226 ENSEMBL:ENSMUSG00000064443 MGI:5456003 snRNA gene predicted gene, 26226
4 gene 140.927227 140.932057 negative MGI_C57BL6J_5593534 Gm34375 NCBI_Gene:102637611 MGI:5593534 lncRNA gene predicted gene, 34375
4 gene 140.947666 140.957902 negative MGI_C57BL6J_3702680 Gm13031 NCBI_Gene:100126227,ENSEMBL:ENSMUSG00000087698 MGI:3702680 lncRNA gene predicted gene 13031
4 gene 140.960427 140.961283 negative MGI_C57BL6J_5593590 Gm34431 NCBI_Gene:102637683 MGI:5593590 lncRNA gene predicted gene, 34431
4 gene 140.961203 140.979197 positive MGI_C57BL6J_1914930 Sdhb NCBI_Gene:67680,ENSEMBL:ENSMUSG00000009863 MGI:1914930 protein coding gene succinate dehydrogenase complex, subunit B, iron sulfur (Ip)
4 gene 140.986861 141.007701 positive MGI_C57BL6J_1922022 Atp13a2 NCBI_Gene:74772,ENSEMBL:ENSMUSG00000036622 MGI:1922022 protein coding gene ATPase type 13A2
4 gene 141.010418 141.015984 positive MGI_C57BL6J_99559 Mfap2 NCBI_Gene:17150,ENSEMBL:ENSMUSG00000060572 MGI:99559 protein coding gene microfibrillar-associated protein 2
4 gene 141.016637 141.060616 negative MGI_C57BL6J_3529431 Crocc NCBI_Gene:230872,ENSEMBL:ENSMUSG00000040860 MGI:3529431 protein coding gene ciliary rootlet coiled-coil, rootletin
4 gene 141.066512 141.078358 negative MGI_C57BL6J_1913397 Necap2 NCBI_Gene:66147,ENSEMBL:ENSMUSG00000028923 MGI:1913397 protein coding gene NECAP endocytosis associated 2
4 pseudogene 141.084841 141.085710 positive MGI_C57BL6J_3651114 Gm13047 NCBI_Gene:638991,ENSEMBL:ENSMUSG00000082246 MGI:3651114 pseudogene predicted gene 13047
4 gene 141.088318 141.112760 positive MGI_C57BL6J_3607787 Spata21 NCBI_Gene:329972,ENSEMBL:ENSMUSG00000045004 MGI:3607787 protein coding gene spermatogenesis associated 21
4 gene 141.112978 141.139796 negative MGI_C57BL6J_1098672 Szrd1 NCBI_Gene:213491,ENSEMBL:ENSMUSG00000040842 MGI:1098672 protein coding gene SUZ RNA binding domain containing 1
4 gene 141.115660 141.118087 positive MGI_C57BL6J_3704238 4921514A10Rik ENSEMBL:ENSMUSG00000097620 MGI:3704238 lncRNA gene RIKEN cDNA 4921514A10 gene
4 gene 141.147908 141.204062 positive MGI_C57BL6J_1924992 Fbxo42 NCBI_Gene:213499,ENSEMBL:ENSMUSG00000028920 MGI:1924992 protein coding gene F-box protein 42
4 gene 141.213667 141.226756 positive MGI_C57BL6J_1923416 Cplane2 NCBI_Gene:76166,ENSEMBL:ENSMUSG00000073733 MGI:1923416 protein coding gene ciliogenesis and planar polarity effector 2
4 gene 141.238179 141.239453 negative MGI_C57BL6J_3641643 C630004L07Rik ENSEMBL:ENSMUSG00000103366 MGI:3641643 unclassified gene RIKEN cDNA C630004L07 gene
4 gene 141.239499 141.257915 positive MGI_C57BL6J_1925912 Arhgef19 NCBI_Gene:213649,ENSEMBL:ENSMUSG00000028919 MGI:1925912 protein coding gene Rho guanine nucleotide exchange factor (GEF) 19
4 gene 141.261762 141.266016 negative MGI_C57BL6J_3649999 Gm13055 ENSEMBL:ENSMUSG00000085774 MGI:3649999 lncRNA gene predicted gene 13055
4 gene 141.278374 141.279794 positive MGI_C57BL6J_3650725 Gm13056 NCBI_Gene:100503810,ENSEMBL:ENSMUSG00000085395 MGI:3650725 lncRNA gene predicted gene 13056
4 gene 141.301221 141.329384 positive MGI_C57BL6J_95278 Epha2 NCBI_Gene:13836,ENSEMBL:ENSMUSG00000006445 MGI:95278 protein coding gene Eph receptor A2
4 gene 141.346164 141.346240 positive MGI_C57BL6J_5455467 Gm25690 ENSEMBL:ENSMUSG00000093180 MGI:5455467 miRNA gene predicted gene, 25690
4 gene 141.347814 141.350853 positive MGI_C57BL6J_3651959 Gm13074 ENSEMBL:ENSMUSG00000085836 MGI:3651959 lncRNA gene predicted gene 13074
4 pseudogene 141.356888 141.357091 negative MGI_C57BL6J_3651957 Gm13076 NCBI_Gene:102637915,ENSEMBL:ENSMUSG00000084238 MGI:3651957 pseudogene predicted gene 13076
4 gene 141.368192 141.384175 positive MGI_C57BL6J_2685539 Fam131c NCBI_Gene:277743,ENSEMBL:ENSMUSG00000006218 MGI:2685539 protein coding gene family with sequence similarity 131, member C
4 gene 141.384610 141.398724 negative MGI_C57BL6J_1329026 Clcnka NCBI_Gene:12733,ENSEMBL:ENSMUSG00000033770 MGI:1329026 protein coding gene chloride channel, voltage-sensitive Ka
4 gene 141.398829 141.411191 positive MGI_C57BL6J_3651958 Gm13075 ENSEMBL:ENSMUSG00000086061 MGI:3651958 lncRNA gene predicted gene 13075
4 gene 141.399759 141.400636 negative MGI_C57BL6J_5593852 Gm34693 NCBI_Gene:102638025 MGI:5593852 lncRNA gene predicted gene, 34693
4 gene 141.404353 141.416014 negative MGI_C57BL6J_1930643 Clcnkb NCBI_Gene:56365,ENSEMBL:ENSMUSG00000006216 MGI:1930643 protein coding gene chloride channel, voltage-sensitive Kb
4 gene 141.420779 141.425311 positive MGI_C57BL6J_1352494 Hspb7 NCBI_Gene:29818,ENSEMBL:ENSMUSG00000006221 MGI:1352494 protein coding gene heat shock protein family, member 7 (cardiovascular)
4 gene 141.432672 141.436105 negative MGI_C57BL6J_2685540 Srarp NCBI_Gene:277744,ENSEMBL:ENSMUSG00000070637 MGI:2685540 protein coding gene steroid receptor associated and regulated protein
4 gene 141.443986 141.444658 negative MGI_C57BL6J_5625222 Gm42337 NCBI_Gene:105247198 MGI:5625222 lncRNA gene predicted gene, 42337
4 gene 141.444654 141.467937 positive MGI_C57BL6J_107410 Zbtb17 NCBI_Gene:22642,ENSEMBL:ENSMUSG00000006215 MGI:107410 protein coding gene zinc finger and BTB domain containing 17
4 gene 141.467885 141.538637 negative MGI_C57BL6J_1891706 Spen NCBI_Gene:56381,ENSEMBL:ENSMUSG00000040761 MGI:1891706 protein coding gene spen family transcription repressor
4 gene 141.535513 141.537422 positive MGI_C57BL6J_3782299 Gm4123 NCBI_Gene:100042951 MGI:3782299 unclassified gene predicted gene 4123
4 gene 141.539209 141.543605 positive MGI_C57BL6J_2443748 B830004H01Rik NA NA unclassified non-coding RNA gene RIKEN cDNA B830004H01 gene
4 gene 141.546162 141.548313 positive MGI_C57BL6J_2444063 B330016D10Rik NCBI_Gene:320456,ENSEMBL:ENSMUSG00000048406 MGI:2444063 lncRNA gene RIKEN cDNA B330016D10 gene
4 gene 141.576062 141.606096 negative MGI_C57BL6J_1921452 Fblim1 NCBI_Gene:74202,ENSEMBL:ENSMUSG00000006219 MGI:1921452 protein coding gene filamin binding LIM protein 1
4 gene 141.613376 141.618633 negative MGI_C57BL6J_2384869 Tmem82 NCBI_Gene:213989,ENSEMBL:ENSMUSG00000043085 MGI:2384869 protein coding gene transmembrane protein 82
4 gene 141.614026 141.615604 positive MGI_C57BL6J_2140323 AI507597 NCBI_Gene:100165,ENSEMBL:ENSMUSG00000073731 MGI:2140323 lncRNA gene expressed sequence AI507597
4 gene 141.618819 141.624002 negative MGI_C57BL6J_2686215 Slc25a34 NCBI_Gene:384071,ENSEMBL:ENSMUSG00000040740 MGI:2686215 protein coding gene solute carrier family 25, member 34
4 gene 141.625732 141.664899 negative MGI_C57BL6J_1916832 Plekhm2 NCBI_Gene:69582,ENSEMBL:ENSMUSG00000028917 MGI:1916832 protein coding gene pleckstrin homology domain containing, family M (with RUN domain) member 2
4 gene 141.652124 141.654920 positive MGI_C57BL6J_1921207 4930451G21Rik NA NA unclassified gene RIKEN cDNA 4930451G21 gene
4 gene 141.677549 141.723419 negative MGI_C57BL6J_1917244 Ddi2 NCBI_Gene:68817,ENSEMBL:ENSMUSG00000078515 MGI:1917244 protein coding gene DNA-damage inducible protein 2
4 gene 141.683563 141.685716 negative MGI_C57BL6J_3526447 Rsc1a1 NCBI_Gene:69994,ENSEMBL:ENSMUSG00000040715 MGI:3526447 protein coding gene regulatory solute carrier protein, family 1, member 1
4 gene 141.729503 141.743817 positive MGI_C57BL6J_5594022 Gm34863 NCBI_Gene:102638257 MGI:5594022 lncRNA gene predicted gene, 34863
4 gene 141.746672 141.759263 positive MGI_C57BL6J_1923236 Agmat NCBI_Gene:75986,ENSEMBL:ENSMUSG00000040706 MGI:1923236 protein coding gene agmatine ureohydrolase (agmatinase)
4 gene 141.760189 141.790931 negative MGI_C57BL6J_2442146 Dnajc16 NCBI_Gene:214063,ENSEMBL:ENSMUSG00000040697 MGI:2442146 protein coding gene DnaJ heat shock protein family (Hsp40) member C16
4 gene 141.793612 141.815978 positive MGI_C57BL6J_1277950 Casp9 NCBI_Gene:12371,ENSEMBL:ENSMUSG00000028914 MGI:1277950 protein coding gene caspase 9
4 gene 141.814962 141.826160 negative MGI_C57BL6J_95316 Cela2a NCBI_Gene:13706,ENSEMBL:ENSMUSG00000058579 MGI:95316 protein coding gene chymotrypsin-like elastase family, member 2A
4 gene 141.814962 141.846359 negative MGI_C57BL6J_1923951 Ctrc NCBI_Gene:76701,ENSEMBL:ENSMUSG00000062478 MGI:1923951 protein coding gene chymotrypsin C (caldecrin)
4 gene 141.844321 141.846990 positive MGI_C57BL6J_1916389 Ctrcos NCBI_Gene:69139,ENSEMBL:ENSMUSG00000086818 MGI:1916389 antisense lncRNA gene chymotrypsin C (caldecrin), opposite strand
4 gene 141.848343 141.858453 positive MGI_C57BL6J_5594193 Gm35034 NCBI_Gene:108168984 MGI:5594193 lncRNA gene predicted gene, 35034
4 gene 141.858142 141.874920 negative MGI_C57BL6J_106504 Efhd2 NCBI_Gene:27984,ENSEMBL:ENSMUSG00000040659 MGI:106504 protein coding gene EF hand domain containing 2
4 gene 141.875707 141.877033 positive MGI_C57BL6J_5580073 Gm29367 ENSEMBL:ENSMUSG00000100396 MGI:5580073 lncRNA gene predicted gene 29367
4 gene 141.879684 141.885620 negative MGI_C57BL6J_5826511 Gm46874 NCBI_Gene:108168983 MGI:5826511 lncRNA gene predicted gene, 46874
4 gene 141.881281 141.900288 positive MGI_C57BL6J_3651870 Fhad1os2 NCBI_Gene:102638933,ENSEMBL:ENSMUSG00000085922 MGI:3651870 antisense lncRNA gene forkhead-associated (FHA) phosphopeptide binding domain 1, opposite strand 2
4 gene 141.890430 142.015126 negative MGI_C57BL6J_1920323 Fhad1 NCBI_Gene:329977,ENSEMBL:ENSMUSG00000051435 MGI:1920323 protein coding gene forkhead-associated (FHA) phosphopeptide binding domain 1
4 gene 141.909876 141.915922 positive MGI_C57BL6J_5625223 Gm42338 NCBI_Gene:105247199 MGI:5625223 lncRNA gene predicted gene, 42338
4 gene 141.920920 141.932783 positive MGI_C57BL6J_5594454 Gm35295 NCBI_Gene:102638820 MGI:5594454 lncRNA gene predicted gene, 35295
4 pseudogene 141.976779 141.977343 positive MGI_C57BL6J_3650255 Gm13059 ENSEMBL:ENSMUSG00000081079 MGI:3650255 pseudogene predicted gene 13059
4 gene 141.982992 141.986797 positive MGI_C57BL6J_3649995 Fhad1os1 NCBI_Gene:545691,ENSEMBL:ENSMUSG00000085424 MGI:3649995 antisense lncRNA gene forkhead-associated (FHA) phosphopeptide binding domain 1, opposite strand 1
4 gene 142.017898 142.028996 positive MGI_C57BL6J_1926167 4930455G09Rik NCBI_Gene:78917,ENSEMBL:ENSMUSG00000085761 MGI:1926167 lncRNA gene RIKEN cDNA 4930455G09 gene
4 gene 142.030990 142.084569 negative MGI_C57BL6J_2384874 Tmem51 NCBI_Gene:214359,ENSEMBL:ENSMUSG00000040616 MGI:2384874 protein coding gene transmembrane protein 51
4 gene 142.042912 142.048578 negative MGI_C57BL6J_3651989 Gm13053 ENSEMBL:ENSMUSG00000085574 MGI:3651989 lncRNA gene predicted gene 13053
4 gene 142.083972 142.088101 positive MGI_C57BL6J_3642733 Tmem51os1 NCBI_Gene:100038693,ENSEMBL:ENSMUSG00000073728 MGI:3642733 antisense lncRNA gene Tmem51 opposite strand 1
4 gene 142.102390 142.239401 negative MGI_C57BL6J_1918779 Kazn NCBI_Gene:71529,ENSEMBL:ENSMUSG00000040606 MGI:1918779 protein coding gene kazrin, periplakin interacting protein
4 gene 142.126678 142.128190 positive MGI_C57BL6J_5594740 Gm35581 NCBI_Gene:102639222 MGI:5594740 lncRNA gene predicted gene, 35581
4 gene 142.180602 142.184139 positive MGI_C57BL6J_3649476 Gm13062 ENSEMBL:ENSMUSG00000087525 MGI:3649476 lncRNA gene predicted gene 13062
4 gene 142.239350 142.242570 positive MGI_C57BL6J_5594690 Gm35531 NCBI_Gene:102639151 MGI:5594690 lncRNA gene predicted gene, 35531
4 gene 142.255661 142.256076 negative MGI_C57BL6J_1920742 1700085G17Rik NA NA unclassified gene RIKEN cDNA 1700085G17 gene
4 gene 142.307765 142.346475 negative MGI_C57BL6J_3651990 Gm13052 ENSEMBL:ENSMUSG00000085816 MGI:3651990 lncRNA gene predicted gene 13052
4 gene 142.348717 142.361007 positive MGI_C57BL6J_5826512 Gm46875 NCBI_Gene:108168985 MGI:5826512 lncRNA gene predicted gene, 46875
4 gene 142.407124 142.414307 negative MGI_C57BL6J_5625224 Gm42339 NCBI_Gene:105247200 MGI:5625224 lncRNA gene predicted gene, 42339
4 gene 142.421678 142.422953 negative MGI_C57BL6J_3665284 C030029H13Rik NA NA unclassified gene Riken cDNA C030029H13 gene
4 gene 142.495588 142.499568 positive MGI_C57BL6J_5594911 Gm35752 NCBI_Gene:102639438 MGI:5594911 lncRNA gene predicted gene, 35752
4 gene 142.598441 143.074839 negative MGI_C57BL6J_1917975 6330411D24Rik ENSEMBL:ENSMUSG00000110067 MGI:1917975 lncRNA gene RIKEN cDNA 6330411D24 gene
4 gene 142.631738 142.635423 positive MGI_C57BL6J_5625227 Gm42342 NCBI_Gene:105247203 MGI:5625227 lncRNA gene predicted gene, 42342
4 gene 142.641817 142.663123 positive MGI_C57BL6J_5625225 Gm42340 NCBI_Gene:105247201 MGI:5625225 lncRNA gene predicted gene, 42340
4 gene 142.643385 142.647566 negative MGI_C57BL6J_5625226 Gm42341 NCBI_Gene:105247202 MGI:5625226 lncRNA gene predicted gene, 42341
4 gene 142.790808 142.791026 positive MGI_C57BL6J_5610852 Gm37624 ENSEMBL:ENSMUSG00000103678 MGI:5610852 unclassified gene predicted gene, 37624
4 gene 143.102689 143.106331 negative MGI_C57BL6J_1926077 5830426C09Rik NA NA unclassified gene RIKEN cDNA 5830426C09 gene
4 gene 143.107391 143.212995 negative MGI_C57BL6J_107628 Prdm2 NCBI_Gene:110593,ENSEMBL:ENSMUSG00000057637 MGI:107628 protein coding gene PR domain containing 2, with ZNF domain
4 gene 143.136100 143.136162 negative MGI_C57BL6J_5562764 Mir7021 miRBase:MI0022870,NCBI_Gene:102465618,ENSEMBL:ENSMUSG00000106597 MGI:5562764 miRNA gene microRNA 7021
4 pseudogene 143.152572 143.153030 positive MGI_C57BL6J_3650684 Gm13038 ENSEMBL:ENSMUSG00000081838 MGI:3650684 pseudogene predicted gene 13038
4 pseudogene 143.166597 143.167442 positive MGI_C57BL6J_3649997 Gm13039 NCBI_Gene:100384872,ENSEMBL:ENSMUSG00000083826 MGI:3649997 pseudogene predicted gene 13039
4 gene 143.204065 143.204196 positive MGI_C57BL6J_5451816 Gm22039 ENSEMBL:ENSMUSG00000087903 MGI:5451816 snoRNA gene predicted gene, 22039
4 gene 143.211960 143.215002 positive MGI_C57BL6J_3646960 Gm6687 NA NA protein coding gene predicted gene 6687
4 pseudogene 143.242024 143.243368 negative MGI_C57BL6J_3650664 Eef2-ps2 NCBI_Gene:433776,ENSEMBL:ENSMUSG00000082575 MGI:3650664 pseudogene eukaryotic translation elongation factor 2, pseudogene 2
4 gene 143.267409 143.299564 negative MGI_C57BL6J_103098 Pdpn NCBI_Gene:14726,ENSEMBL:ENSMUSG00000028583 MGI:103098 protein coding gene podoplanin
4 gene 143.340399 143.340706 positive MGI_C57BL6J_5456090 Gm26313 ENSEMBL:ENSMUSG00000088395 MGI:5456090 unclassified non-coding RNA gene predicted gene, 26313
4 gene 143.346471 143.371032 positive MGI_C57BL6J_2442845 Lrrc38 NCBI_Gene:242735,ENSEMBL:ENSMUSG00000028584 MGI:2442845 protein coding gene leucine rich repeat containing 38
4 pseudogene 143.389462 143.390510 positive MGI_C57BL6J_3651262 Anp32b-ps1 NCBI_Gene:621961,ENSEMBL:ENSMUSG00000081792 MGI:3651262 pseudogene Bacidic (leucine-rich) nuclear phosphoprotein 32 family, member B, pseudogene 1
4 gene 143.394359 143.400160 positive MGI_C57BL6J_1890541 Pramel1 NCBI_Gene:83491,ENSEMBL:ENSMUSG00000041805 MGI:1890541 protein coding gene preferentially expressed antigen in melanoma-like 1
4 pseudogene 143.402344 143.403413 positive MGI_C57BL6J_3649502 Gm13045 ENSEMBL:ENSMUSG00000082407 MGI:3649502 pseudogene predicted gene 13045
4 gene 143.412311 143.421091 positive MGI_C57BL6J_2140473 Pramef8 NCBI_Gene:242736,ENSEMBL:ENSMUSG00000046862 MGI:2140473 protein coding gene PRAME family member 8
4 gene 143.437164 143.450324 negative MGI_C57BL6J_2684051 Oog4 NCBI_Gene:242737,ENSEMBL:ENSMUSG00000047799 MGI:2684051 protein coding gene oogenesin 4
4 pseudogene 143.456835 143.460573 negative MGI_C57BL6J_3651155 Gm13042 NCBI_Gene:666015,ENSEMBL:ENSMUSG00000083930 MGI:3651155 pseudogene predicted gene 13042
4 pseudogene 143.464274 143.464774 negative MGI_C57BL6J_3649503 Gm13046 ENSEMBL:ENSMUSG00000084059 MGI:3649503 pseudogene predicted gene 13046
4 pseudogene 143.499435 143.502508 positive MGI_C57BL6J_3649499 Gm13041 NCBI_Gene:626700,ENSEMBL:ENSMUSG00000083403 MGI:3649499 pseudogene predicted gene 13041
4 gene 143.511343 143.517831 positive MGI_C57BL6J_3649500 Gm13043 NCBI_Gene:545693,ENSEMBL:ENSMUSG00000095409 MGI:3649500 protein coding gene predicted gene 13043
4 gene 143.535954 143.542471 positive MGI_C57BL6J_3649498 Gm13040 NCBI_Gene:100040854,ENSEMBL:ENSMUSG00000070616 MGI:3649498 protein coding gene predicted gene 13040
4 gene 143.551700 143.558236 positive MGI_C57BL6J_3649690 Gm13057 NCBI_Gene:100040861,ENSEMBL:ENSMUSG00000096154 MGI:3649690 protein coding gene predicted gene 13057
4 gene 143.551700 143.573798 positive MGI_C57BL6J_3525148 BC080695 NCBI_Gene:329986,ENSEMBL:ENSMUSG00000070618 MGI:3525148 protein coding gene cDNA sequence BC080695
4 pseudogene 143.594969 143.600962 negative MGI_C57BL6J_3650002 Gm13058 NCBI_Gene:666049,ENSEMBL:ENSMUSG00000081523 MGI:3650002 pseudogene predicted gene 13058
4 pseudogene 143.611633 143.612154 negative MGI_C57BL6J_3650235 Gm13080 NCBI_Gene:100044633,ENSEMBL:ENSMUSG00000044377 MGI:3650235 pseudogene predicted gene 13080
4 gene 143.615003 143.618738 positive MGI_C57BL6J_3650232 Gm13083 NCBI_Gene:279185,ENSEMBL:ENSMUSG00000066688 MGI:3650232 protein coding gene predicted gene 13083
4 gene 143.653760 143.660598 negative MGI_C57BL6J_3649971 Gm13088 NCBI_Gene:277668,ENSEMBL:ENSMUSG00000078513 MGI:3649971 protein coding gene predicted gene 13088
4 pseudogene 143.663143 143.663787 negative MGI_C57BL6J_3650236 Gm13085 ENSEMBL:ENSMUSG00000084351 MGI:3650236 pseudogene predicted gene 13085
4 pseudogene 143.671124 143.673598 positive MGI_C57BL6J_3650233 Gm13082 NCBI_Gene:100040924,ENSEMBL:ENSMUSG00000081227 MGI:3650233 pseudogene predicted gene 13082
4 pseudogene 143.681880 143.685298 positive MGI_C57BL6J_5826498 Gm46861 NCBI_Gene:108168961 MGI:5826498 pseudogene predicted gene, 46861
4 gene 143.696487 143.702711 negative MGI_C57BL6J_3649972 Gm13089 NCBI_Gene:277667,ENSEMBL:ENSMUSG00000070617 MGI:3649972 protein coding gene predicted gene 13089
4 gene 143.719451 143.729158 positive MGI_C57BL6J_3650231 Gm13078 NCBI_Gene:277666,ENSEMBL:ENSMUSG00000046435 MGI:3650231 protein coding gene predicted gene 13078
4 pseudogene 143.735298 143.735553 negative MGI_C57BL6J_3649970 Gm13087 ENSEMBL:ENSMUSG00000082717 MGI:3649970 pseudogene predicted gene 13087
4 pseudogene 143.745787 143.751385 positive MGI_C57BL6J_3650234 Gm13081 ENSEMBL:ENSMUSG00000082030 MGI:3650234 pseudogene predicted gene 13081
4 gene 143.789334 143.795585 positive MGI_C57BL6J_3650478 Gm13023 NCBI_Gene:194227,ENSEMBL:ENSMUSG00000066031 MGI:3650478 protein coding gene predicted gene 13023
4 gene 143.809245 143.816093 negative MGI_C57BL6J_3650237 Gm13084 NCBI_Gene:381569,ENSEMBL:ENSMUSG00000059218 MGI:3650237 protein coding gene predicted gene 13084
4 gene 143.846497 143.853637 positive MGI_C57BL6J_3650203 Gm13103 NCBI_Gene:194225,ENSEMBL:ENSMUSG00000029451 MGI:3650203 protein coding gene predicted gene 13103
4 gene 143.894237 143.900380 negative MGI_C57BL6J_3649940 Pramef6 NCBI_Gene:195555,ENSEMBL:ENSMUSG00000078512 MGI:3649940 protein coding gene PRAME family member 6
4 pseudogene 143.913832 143.916746 positive MGI_C57BL6J_3650205 Gm13100 NCBI_Gene:194224,ENSEMBL:ENSMUSG00000083749 MGI:3650205 pseudogene predicted gene 13100
4 pseudogene 143.928534 143.930760 negative MGI_C57BL6J_3651761 Gm13106 NCBI_Gene:108169006,ENSEMBL:ENSMUSG00000084123 MGI:3651761 pseudogene predicted gene 13106
4 gene 143.948183 143.951016 negative MGI_C57BL6J_3649968 Pramef25 NCBI_Gene:329984,ENSEMBL:ENSMUSG00000078511 MGI:3649968 protein coding gene PRAME family member 25
4 gene 143.964129 143.966950 negative MGI_C57BL6J_3650204 Gm13101 NCBI_Gene:626922,ENSEMBL:ENSMUSG00000078510 MGI:3650204 protein coding gene predicted gene 13101
4 gene 143.991119 143.994369 negative MGI_C57BL6J_3650199 Pramef17 NCBI_Gene:626943,ENSEMBL:ENSMUSG00000078509 MGI:3650199 protein coding gene PRAME family member 17
4 pseudogene 144.033631 144.035610 positive MGI_C57BL6J_3650198 Gm13108 NCBI_Gene:100534283,ENSEMBL:ENSMUSG00000083456 MGI:3650198 pseudogene predicted gene 13108
4 pseudogene 144.041033 144.042482 negative MGI_C57BL6J_3650202 Gm13104 NCBI_Gene:436146,ENSEMBL:ENSMUSG00000095987 MGI:3650202 pseudogene predicted gene 13104
4 gene 144.059126 144.069327 positive MGI_C57BL6J_2156377 Pramel4 NCBI_Gene:347710,ENSEMBL:ENSMUSG00000073724 MGI:2156377 protein coding gene preferentially expressed antigen in melanoma like 4
4 gene 144.087362 144.090870 positive MGI_C57BL6J_5625252 Gm42367 NCBI_Gene:108168962 MGI:5625252 protein coding gene predicted gene, 42367
4 gene 144.099880 144.110101 positive MGI_C57BL6J_3703005 Gm13102 NCBI_Gene:100041077,ENSEMBL:ENSMUSG00000073723 MGI:3703005 protein coding gene predicted gene 13102
4 gene 144.157556 144.162663 negative MGI_C57BL6J_2684047 Oog3 NCBI_Gene:100012,ENSEMBL:ENSMUSG00000050810 MGI:2684047 protein coding gene oogenesin 3
4 gene 144.190717 144.196934 positive MGI_C57BL6J_2684035 Oog2 NCBI_Gene:381570,ENSEMBL:ENSMUSG00000066030 MGI:2684035 protein coding gene oogenesin 2
4 gene 144.206762 144.213318 negative MGI_C57BL6J_2140708 C87977 NCBI_Gene:97187,ENSEMBL:ENSMUSG00000046262 MGI:2140708 protein coding gene expressed sequence C87977
4 pseudogene 144.247777 144.248268 positive MGI_C57BL6J_3651473 Gm13123 ENSEMBL:ENSMUSG00000083708 MGI:3651473 pseudogene predicted gene 13123
4 pseudogene 144.255727 144.257581 negative MGI_C57BL6J_5434367 Gm21012 NCBI_Gene:100534281 MGI:5434367 pseudogene predicted gene, 21012
4 gene 144.270633 144.280488 negative MGI_C57BL6J_2156389 Pramel5 NCBI_Gene:384077,ENSEMBL:ENSMUSG00000036749 MGI:2156389 protein coding gene preferentially expressed antigen in melanoma like 5
4 pseudogene 144.296688 144.298137 positive MGI_C57BL6J_3651691 Gm13120 NCBI_Gene:666150,ENSEMBL:ENSMUSG00000095960 MGI:3651691 pseudogene predicted gene 13120
4 pseudogene 144.302961 144.304941 negative MGI_C57BL6J_3651258 Gm13130 NCBI_Gene:100534282,ENSEMBL:ENSMUSG00000080943 MGI:3651258 pseudogene predicted gene 13130
4 gene 144.330249 144.333465 positive MGI_C57BL6J_3651261 Gm13128 NCBI_Gene:626995,ENSEMBL:ENSMUSG00000078508 MGI:3651261 protein coding gene predicted gene 13128
4 pseudogene 144.345597 144.346049 negative MGI_C57BL6J_3651474 Gm13122 ENSEMBL:ENSMUSG00000084312 MGI:3651474 pseudogene predicted gene 13122
4 gene 144.357942 144.364419 positive MGI_C57BL6J_3651680 Gm13119 NCBI_Gene:433779,ENSEMBL:ENSMUSG00000070619 MGI:3651680 protein coding gene predicted gene 13119
4 gene 144.372760 144.377933 negative MGI_C57BL6J_3712553 Pramef20 NCBI_Gene:627009,ENSEMBL:ENSMUSG00000073721 MGI:3712553 protein coding gene PRAME family member 20
4 gene 144.391674 144.408467 negative MGI_C57BL6J_1924882 Pramef12 NCBI_Gene:77632,ENSEMBL:ENSMUSG00000028591 MGI:1924882 protein coding gene PRAME family member 12
4 gene 144.404868 144.406301 positive MGI_C57BL6J_1925973 Pramef12os ENSEMBL:ENSMUSG00000028590 MGI:1925973 antisense lncRNA gene PRAME family member 12, opposite strand
4 gene 144.418189 144.438793 negative MGI_C57BL6J_1916614 1700012P22Rik NCBI_Gene:69364,ENSEMBL:ENSMUSG00000028589 MGI:1916614 protein coding gene RIKEN cDNA 1700012P22 gene
4 gene 144.451220 144.453641 negative MGI_C57BL6J_3642412 Gm9944 ENSEMBL:ENSMUSG00000095213 MGI:3642412 protein coding gene predicted gene 9944
4 gene 144.453771 144.463756 negative MGI_C57BL6J_2685281 Aadacl3 NCBI_Gene:230883,ENSEMBL:ENSMUSG00000078507 MGI:2685281 protein coding gene arylacetamide deacetylase like 3
4 pseudogene 144.498400 144.498948 negative MGI_C57BL6J_3651681 Gm13118 NCBI_Gene:100417902,ENSEMBL:ENSMUSG00000082835 MGI:3651681 pseudogene predicted gene 13118
4 gene 144.519822 144.529353 positive MGI_C57BL6J_2685880 Aadacl4fm1 NCBI_Gene:381572,ENSEMBL:ENSMUSG00000028593 MGI:2685880 protein coding gene AADACL4 family member 1
4 pseudogene 144.526411 144.527042 negative MGI_C57BL6J_3650486 Gm13121 NCBI_Gene:100041232,ENSEMBL:ENSMUSG00000083390 MGI:3650486 pseudogene predicted gene 13121
4 pseudogene 144.545353 144.548629 negative MGI_C57BL6J_3651475 Gm13126 NCBI_Gene:666194,ENSEMBL:ENSMUSG00000082418 MGI:3651475 pseudogene predicted gene 13126
4 gene 144.555000 144.565134 negative MGI_C57BL6J_3652194 Aadacl4fm2 NCBI_Gene:627085,ENSEMBL:ENSMUSG00000078506 MGI:3652194 protein coding gene AADACL4 family member 2
4 pseudogene 144.587087 144.588967 positive MGI_C57BL6J_3651260 Gm13127 NCBI_Gene:666215,ENSEMBL:ENSMUSG00000070610 MGI:3651260 pseudogene predicted gene 13127
4 gene 144.613707 144.623398 positive MGI_C57BL6J_3650257 Aadacl4 NCBI_Gene:435815,ENSEMBL:ENSMUSG00000070609 MGI:3650257 protein coding gene arylacetamide deacetylase like 4
4 gene 144.669937 144.686368 negative MGI_C57BL6J_2685282 Aadacl4fm4 NCBI_Gene:230890,ENSEMBL:ENSMUSG00000078505 MGI:2685282 protein coding gene AADACL4 family member 4
4 gene 144.703191 144.721454 negative MGI_C57BL6J_3650721 AAdacl4fm3 NCBI_Gene:546849,ENSEMBL:ENSMUSG00000041735 MGI:3650721 protein coding gene AADACL4 family member 3
4 gene 144.765627 144.765792 negative MGI_C57BL6J_5455715 Gm25938 ENSEMBL:ENSMUSG00000077327 MGI:5455715 snRNA gene predicted gene, 25938
4 gene 144.777204 144.786583 negative MGI_C57BL6J_2685284 Aadacl4fm5 NCBI_Gene:329993,ENSEMBL:ENSMUSG00000078504 MGI:2685284 protein coding gene AADACL4 family member 5
4 pseudogene 144.791794 144.792848 positive MGI_C57BL6J_1859808 Prdx2-ps2 NCBI_Gene:666242,ENSEMBL:ENSMUSG00000083998 MGI:1859808 pseudogene peroxiredoxin 2, pseudogene 2
4 pseudogene 144.811271 144.812028 negative MGI_C57BL6J_5826527 Gm46890 NCBI_Gene:108169007 MGI:5826527 pseudogene predicted gene, 46890
4 gene 144.855381 144.898676 negative MGI_C57BL6J_5826513 Gm46876 NCBI_Gene:108168986 MGI:5826513 lncRNA gene predicted gene, 46876
4 gene 144.892608 144.928209 positive MGI_C57BL6J_1315215 Dhrs3 NCBI_Gene:20148,ENSEMBL:ENSMUSG00000066026 MGI:1315215 protein coding gene dehydrogenase/reductase (SDR family) member 3
4 gene 144.904717 145.195370 negative MGI_C57BL6J_2448530 Vps13d NCBI_Gene:230895,ENSEMBL:ENSMUSG00000020220 MGI:2448530 protein coding gene vacuolar protein sorting 13D
4 gene 144.938570 144.954151 negative MGI_C57BL6J_5625229 Gm42344 NCBI_Gene:105247205 MGI:5625229 lncRNA gene predicted gene, 42344
4 gene 144.957155 144.958848 negative MGI_C57BL6J_5611302 Gm38074 ENSEMBL:ENSMUSG00000103911 MGI:5611302 unclassified gene predicted gene, 38074
4 gene 144.963353 144.965593 positive MGI_C57BL6J_5595476 Gm36317 NCBI_Gene:102640189 MGI:5595476 lncRNA gene predicted gene, 36317
4 gene 145.145046 145.150967 positive MGI_C57BL6J_5625228 Gm42343 NCBI_Gene:105247204 MGI:5625228 lncRNA gene predicted gene, 42343
4 gene 145.212368 145.246870 negative MGI_C57BL6J_1314883 Tnfrsf1b NCBI_Gene:21938,ENSEMBL:ENSMUSG00000028599 MGI:1314883 protein coding gene tumor necrosis factor receptor superfamily, member 1b
4 gene 145.248555 145.264971 negative MGI_C57BL6J_5595392 Gm36233 NCBI_Gene:102640078 MGI:5595392 lncRNA gene predicted gene, 36233
4 gene 145.267137 145.315164 negative MGI_C57BL6J_99908 Tnfrsf8 NCBI_Gene:21941,ENSEMBL:ENSMUSG00000028602 MGI:99908 protein coding gene tumor necrosis factor receptor superfamily, member 8
4 pseudogene 145.390943 145.391660 positive MGI_C57BL6J_3650678 Gm13024 NCBI_Gene:666282,ENSEMBL:ENSMUSG00000082758 MGI:3650678 pseudogene predicted gene 13024
4 pseudogene 145.404306 145.404399 positive MGI_C57BL6J_3652162 Gm13224 ENSEMBL:ENSMUSG00000084272 MGI:3652162 pseudogene predicted gene 13224
4 gene 145.410245 145.449756 positive MGI_C57BL6J_3651931 Platr16 ENSEMBL:ENSMUSG00000085101 MGI:3651931 lncRNA gene pluripotency associated transcript 16
4 pseudogene 145.433410 145.450774 positive MGI_C57BL6J_5625231 Gm42346 NCBI_Gene:105247207 MGI:5625231 pseudogene predicted gene, 42346
4 pseudogene 145.446740 145.450888 positive MGI_C57BL6J_3651934 Gm13230 ENSEMBL:ENSMUSG00000082082 MGI:3651934 pseudogene predicted gene 13230
4 pseudogene 145.455633 145.456379 positive MGI_C57BL6J_3652163 Gm13223 NCBI_Gene:100418367,ENSEMBL:ENSMUSG00000083081 MGI:3652163 pseudogene predicted gene 13223
4 pseudogene 145.464204 145.467961 positive MGI_C57BL6J_2443330 Smarca5-ps NCBI_Gene:545700,ENSEMBL:ENSMUSG00000052912 MGI:2443330 pseudogene SWI/SNF related, matrix associated, actin depenent ragulator of chromatin, subfamily a, member 5, pseudogene
4 pseudogene 145.469029 145.471568 negative MGI_C57BL6J_3651933 Gm13229 NCBI_Gene:102634135,ENSEMBL:ENSMUSG00000087076 MGI:3651933 pseudogene predicted gene 13229
4 gene 145.510759 145.539188 positive MGI_C57BL6J_3652161 Zfp990 NCBI_Gene:101056073,ENSEMBL:ENSMUSG00000078503 MGI:3652161 protein coding gene zinc finger protein 990
4 pseudogene 145.560513 145.560889 positive MGI_C57BL6J_5439447 Gm21978 NCBI_Gene:100125275,ENSEMBL:ENSMUSG00000096864 MGI:5439447 pseudogene predicted gene 21978
4 pseudogene 145.574528 145.575161 positive MGI_C57BL6J_3651932 Gm13228 ENSEMBL:ENSMUSG00000082352 MGI:3651932 pseudogene predicted gene 13228
4 pseudogene 145.576889 145.577330 negative MGI_C57BL6J_3651282 Gm13226 NCBI_Gene:545701,ENSEMBL:ENSMUSG00000083454 MGI:3651282 pseudogene predicted gene 13226
4 pseudogene 145.579036 145.579173 positive MGI_C57BL6J_3652164 Gm13222 ENSEMBL:ENSMUSG00000080732 MGI:3652164 pseudogene predicted gene 13222
4 gene 145.585166 145.625345 positive MGI_C57BL6J_3651014 Gm13212 NCBI_Gene:433801,ENSEMBL:ENSMUSG00000078502 MGI:3651014 protein coding gene predicted gene 13212
4 gene 145.601963 145.712426 negative MGI_C57BL6J_5477257 Gm26763 NCBI_Gene:102633440,ENSEMBL:ENSMUSG00000097661 MGI:5477257 lncRNA gene predicted gene, 26763
4 pseudogene 145.632504 145.633347 positive MGI_C57BL6J_3649926 Gm13234 NCBI_Gene:666334,ENSEMBL:ENSMUSG00000083562 MGI:3649926 pseudogene predicted gene 13234
4 pseudogene 145.641158 145.644466 positive MGI_C57BL6J_3649243 Gm13231 NCBI_Gene:545703,ENSEMBL:ENSMUSG00000081885 MGI:3649243 pseudogene predicted gene 13231
4 pseudogene 145.646723 145.647237 negative MGI_C57BL6J_3649659 Gm13249 NCBI_Gene:384081,ENSEMBL:ENSMUSG00000095517 MGI:3649659 pseudogene predicted gene 13249
4 gene 145.670685 145.704441 positive MGI_C57BL6J_3712454 Zfp980 NCBI_Gene:100041379,ENSEMBL:ENSMUSG00000058186 MGI:3712454 protein coding gene zinc finger protein 980
4 pseudogene 145.689842 145.690478 positive MGI_C57BL6J_3650779 Gm13239 NCBI_Gene:666349,ENSEMBL:ENSMUSG00000082615 MGI:3650779 pseudogene predicted gene 13239
4 pseudogene 145.701675 145.775988 positive MGI_C57BL6J_3761370 Vmn2r-ps15 NCBI_Gene:100125279,ENSEMBL:ENSMUSG00000094177 MGI:3761370 pseudogene vomeronasal 2, receptor, pseudogene 15
4 pseudogene 145.729439 145.730355 negative MGI_C57BL6J_3649252 Gm13232 NCBI_Gene:666351,ENSEMBL:ENSMUSG00000084279 MGI:3649252 pseudogene predicted gene 13232
4 pseudogene 145.745716 145.747401 positive MGI_C57BL6J_3650036 Gm13244 NCBI_Gene:100534387,ENSEMBL:ENSMUSG00000082334 MGI:3650036 pseudogene predicted gene 13244
4 gene 145.762929 145.764958 positive MGI_C57BL6J_3705163 Gm13236 ENSEMBL:ENSMUSG00000087513 MGI:3705163 lncRNA gene predicted gene 13236
4 pseudogene 145.774278 145.775283 positive MGI_C57BL6J_3649654 Gm13243 NCBI_Gene:100417615,ENSEMBL:ENSMUSG00000094417 MGI:3649654 pseudogene predicted gene 13243
4 pseudogene 145.789515 145.831978 positive MGI_C57BL6J_1917255 Znf41-ps NCBI_Gene:70005,ENSEMBL:ENSMUSG00000084350 MGI:1917255 pseudogene ZNF41, pseudogene
4 pseudogene 145.837219 145.837998 positive MGI_C57BL6J_3652104 Gm13238 NCBI_Gene:236069,ENSEMBL:ENSMUSG00000096233 MGI:3652104 pseudogene predicted gene 13238
4 pseudogene 145.843493 145.844733 negative MGI_C57BL6J_3649657 Gm13246 NCBI_Gene:102633201,ENSEMBL:ENSMUSG00000083235 MGI:3649657 pseudogene predicted gene 13246
4 gene 145.868794 145.899975 positive MGI_C57BL6J_3649925 Zfp986 ENSEMBL:ENSMUSG00000078500 MGI:3649925 protein coding gene zinc finger protein 986
4 pseudogene 146.058776 146.059523 positive MGI_C57BL6J_3650250 Gm13036 NCBI_Gene:100418368,ENSEMBL:ENSMUSG00000081595 MGI:3650250 pseudogene predicted gene 13036
4 pseudogene 146.067524 146.070928 positive MGI_C57BL6J_3650252 Gm13034 NCBI_Gene:627585,ENSEMBL:ENSMUSG00000082195 MGI:3650252 pseudogene predicted gene 13034
4 pseudogene 146.073194 146.073724 negative MGI_C57BL6J_3650251 Gm13035 NCBI_Gene:102637947,ENSEMBL:ENSMUSG00000083733 MGI:3650251 pseudogene predicted gene 13035
4 gene 146.097298 146.126624 positive MGI_C57BL6J_3702694 Zfp987 NCBI_Gene:626316,ENSEMBL:ENSMUSG00000066009 MGI:3702694 protein coding gene zinc finger protein 987
4 pseudogene 146.124687 146.264895 positive MGI_C57BL6J_3761372 Vmn2r-ps17 NCBI_Gene:434514,ENSEMBL:ENSMUSG00000095096 MGI:3761372 pseudogene vomeronasal 2, receptor, pseudogene 17
4 gene 146.153456 147.024959 negative MGI_C57BL6J_5477067 Gm26573 ENSEMBL:ENSMUSG00000096958 MGI:5477067 lncRNA gene predicted gene, 26573
4 gene 146.156824 146.198756 positive MGI_C57BL6J_3705222 Zfp600 NCBI_Gene:667666,ENSEMBL:ENSMUSG00000066007 MGI:3705222 protein coding gene zinc finger protein 600
4 gene 146.167522 146.264299 negative MGI_C57BL6J_3650210 Gm13165 NCBI_Gene:105247209,ENSEMBL:ENSMUSG00000086654 MGI:3650210 lncRNA gene predicted gene 13165
4 pseudogene 146.178124 146.178766 positive MGI_C57BL6J_3651095 Gm13170 NCBI_Gene:626480,ENSEMBL:ENSMUSG00000081522 MGI:3651095 pseudogene predicted gene 13170
4 pseudogene 146.223890 146.224806 negative MGI_C57BL6J_3650208 Gm13167 NCBI_Gene:666474,ENSEMBL:ENSMUSG00000081671 MGI:3650208 pseudogene predicted gene 13167
4 pseudogene 146.239954 146.241633 positive MGI_C57BL6J_3651793 Gm13169 NCBI_Gene:100534388,ENSEMBL:ENSMUSG00000084127 MGI:3651793 pseudogene predicted gene 13169
4 gene 146.251829 146.278434 positive MGI_C57BL6J_3705130 Gm13166 ENSEMBL:ENSMUSG00000085525 MGI:3705130 lncRNA gene predicted gene 13166
4 pseudogene 146.263559 146.264190 positive MGI_C57BL6J_3650212 Gm13168 ENSEMBL:ENSMUSG00000081460 MGI:3650212 pseudogene predicted gene 13168
4 pseudogene 146.445134 146.605510 positive MGI_C57BL6J_3761371 Vmn2r-ps16 NCBI_Gene:100125280,ENSEMBL:ENSMUSG00000095460 MGI:3761371 pseudogene vomeronasal 2, receptor, pseudogene 16
4 gene 146.449023 146.470292 positive MGI_C57BL6J_3700963 Zfp992 NCBI_Gene:433791,ENSEMBL:ENSMUSG00000070605 MGI:3700963 protein coding gene zinc finger protein 992
4 pseudogene 146.474799 146.478206 positive MGI_C57BL6J_3649920 Gm13241 NCBI_Gene:433790,ENSEMBL:ENSMUSG00000073716 MGI:3649920 pseudogene predicted gene 13241
4 pseudogene 146.480667 146.480926 positive MGI_C57BL6J_3649656 Gm13245 ENSEMBL:ENSMUSG00000081998 MGI:3649656 pseudogene predicted gene 13245
4 gene 146.502000 146.539395 positive MGI_C57BL6J_3700965 Zfp981 NCBI_Gene:100041433,ENSEMBL:ENSMUSG00000056300 MGI:3700965 protein coding gene zinc finger protein 981
4 gene 146.509094 146.511764 negative MGI_C57BL6J_5477374 Gm26880 ENSEMBL:ENSMUSG00000096979 MGI:5477374 lncRNA gene predicted gene, 26880
4 gene 146.519039 146.546873 negative MGI_C57BL6J_1914774 1700095A21Rik NCBI_Gene:67524,ENSEMBL:ENSMUSG00000086046 MGI:1914774 lncRNA gene RIKEN cDNA 1700095A21 gene
4 pseudogene 146.564183 146.565229 negative MGI_C57BL6J_3649924 Gm13237 NCBI_Gene:666390,ENSEMBL:ENSMUSG00000095865 MGI:3649924 pseudogene predicted gene 13237
4 pseudogene 146.580034 146.583304 positive MGI_C57BL6J_3649253 Gm13233 NCBI_Gene:100534386,ENSEMBL:ENSMUSG00000083038 MGI:3649253 pseudogene predicted gene 13233
4 pseudogene 146.603764 146.604776 positive MGI_C57BL6J_3650771 Gm13240 NCBI_Gene:100417614,ENSEMBL:ENSMUSG00000096366 MGI:3650771 pseudogene predicted gene 13240
4 gene 146.610855 146.658411 positive MGI_C57BL6J_3713585 Zfp993 NCBI_Gene:100503000,ENSEMBL:ENSMUSG00000063245 MGI:3713585 protein coding gene zinc finger protein 993
4 gene 146.727752 146.729785 negative MGI_C57BL6J_5589840 Gm30681 NCBI_Gene:102632663 MGI:5589840 lncRNA gene predicted gene, 30681
4 pseudogene 146.749615 146.750519 negative MGI_C57BL6J_5434231 Gm20875 NCBI_Gene:100041490 MGI:5434231 pseudogene predicted gene, 20875
4 pseudogene 146.816572 146.821704 negative MGI_C57BL6J_5826533 Gm46896 NCBI_Gene:108169015 MGI:5826533 pseudogene predicted gene, 46896
4 pseudogene 146.828929 146.838175 negative MGI_C57BL6J_5434437 Gm21082 NCBI_Gene:100861620 MGI:5434437 pseudogene predicted gene, 21082
4 gene 146.891696 146.909590 negative MGI_C57BL6J_5434766 Gm21411 ENSEMBL:ENSMUSG00000045699 MGI:5434766 lncRNA gene predicted gene, 21411
4 pseudogene 146.932395 146.933560 positive MGI_C57BL6J_5434116 Gm20760 NCBI_Gene:631415,ENSEMBL:ENSMUSG00000093919 MGI:5434116 pseudogene predicted gene, 20760
4 pseudogene 146.942276 146.946029 positive MGI_C57BL6J_3649297 Gm13140 NCBI_Gene:626288,ENSEMBL:ENSMUSG00000083027 MGI:3649297 pseudogene predicted gene 13140
4 pseudogene 146.948139 146.948498 negative MGI_C57BL6J_3651738 Gm13149 NCBI_Gene:102631940,ENSEMBL:ENSMUSG00000081260 MGI:3651738 pseudogene predicted gene 13149
4 gene 146.971976 146.990755 positive MGI_C57BL6J_3651739 Zfp989 ENSEMBL:ENSMUSG00000086147 MGI:3651739 protein coding gene zinc finger protein 989
4 pseudogene 146.997669 147.002801 positive MGI_C57BL6J_5826532 Gm46895 NCBI_Gene:108169014 MGI:5826532 pseudogene predicted gene, 46895
4 gene 147.018235 147.492201 negative MGI_C57BL6J_2444536 C230088H06Rik ENSEMBL:ENSMUSG00000097168 MGI:2444536 lncRNA gene RIKEN cDNA C230088H06 gene
4 gene 147.021850 147.060799 positive MGI_C57BL6J_1328322 Rex2 NCBI_Gene:100043034,ENSEMBL:ENSMUSG00000067919 MGI:1328322 protein coding gene reduced expression 2
4 pseudogene 147.040619 147.041443 positive MGI_C57BL6J_3651987 Gm13153 NCBI_Gene:100417333,ENSEMBL:ENSMUSG00000083704 MGI:3651987 pseudogene predicted gene 13153
4 gene 147.063366 147.068436 negative MGI_C57BL6J_1918520 4933438K21Rik NCBI_Gene:71270,ENSEMBL:ENSMUSG00000093617 MGI:1918520 lncRNA gene RIKEN cDNA 4933438K21 gene
4 pseudogene 147.086210 147.087001 negative MGI_C57BL6J_3649984 Gm13160 NCBI_Gene:666514,ENSEMBL:ENSMUSG00000094017 MGI:3649984 pseudogene predicted gene 13160
4 pseudogene 147.102327 147.103984 positive MGI_C57BL6J_3651745 Gm13142 NCBI_Gene:100041561,ENSEMBL:ENSMUSG00000081405 MGI:3651745 pseudogene predicted gene 13142
4 pseudogene 147.125256 147.125816 positive MGI_C57BL6J_3701119 Gm13162 ENSEMBL:ENSMUSG00000082779 MGI:3701119 pseudogene predicted pseudogene 13162
4 gene 147.125256 147.392582 positive MGI_C57BL6J_3701123 Zfp978 NCBI_Gene:108168963,ENSEMBL:ENSMUSG00000078497 MGI:3701123 protein coding gene zinc finger protein 978
4 pseudogene 147.126130 147.126509 positive MGI_C57BL6J_3761373 Vmn2r-ps18 NCBI_Gene:100124576,ENSEMBL:ENSMUSG00000094849 MGI:3761373 pseudogene vomeronasal 2, receptor, pseudogene 18
4 gene 147.132038 147.180579 positive MGI_C57BL6J_3701604 Zfp991 NCBI_Gene:666532,ENSEMBL:ENSMUSG00000067916 MGI:3701604 protein coding gene zinc finger protein 991
4 gene 147.136278 147.457019 positive MGI_C57BL6J_5477118 Gm26624 ENSEMBL:ENSMUSG00000097122 MGI:5477118 lncRNA gene predicted gene, 26624
4 pseudogene 147.187708 147.188487 positive MGI_C57BL6J_3651742 Gm13146 NCBI_Gene:384087,ENSEMBL:ENSMUSG00000095054 MGI:3651742 pseudogene predicted gene 13146
4 pseudogene 147.194099 147.195211 negative MGI_C57BL6J_3651199 Gm13163 NCBI_Gene:102631726,ENSEMBL:ENSMUSG00000082176 MGI:3651199 pseudogene predicted gene 13163
4 gene 147.221860 147.226323 positive MGI_C57BL6J_5625253 Gm42368 NCBI_Gene:105247234 MGI:5625253 protein coding gene predicted gene, 42368
4 pseudogene 147.230284 147.259338 positive MGI_C57BL6J_3651740 Gm13147 ENSEMBL:ENSMUSG00000087207 MGI:3651740 pseudogene predicted gene 13147
4 pseudogene 147.267373 147.268419 positive MGI_C57BL6J_3649982 Gm13158 NCBI_Gene:102640977,ENSEMBL:ENSMUSG00000081627 MGI:3649982 pseudogene predicted gene 13158
4 pseudogene 147.275617 147.279329 positive MGI_C57BL6J_3650404 Gm13135 NCBI_Gene:545716,ENSEMBL:ENSMUSG00000082925 MGI:3650404 pseudogene predicted gene 13135
4 pseudogene 147.281398 147.281941 negative MGI_C57BL6J_3651743 Gm13144 NCBI_Gene:666574,ENSEMBL:ENSMUSG00000094318 MGI:3651743 pseudogene predicted gene 13144
4 gene 147.305674 147.333734 positive MGI_C57BL6J_3651985 Zfp988 ENSEMBL:ENSMUSG00000078498 MGI:3651985 protein coding gene zinc finger protein 988
4 pseudogene 147.378867 147.379772 positive MGI_C57BL6J_3646475 Gm8178 NCBI_Gene:666588,ENSEMBL:ENSMUSG00000096354 MGI:3646475 pseudogene predicted gene 8178
4 gene 147.397168 147.399679 negative MGI_C57BL6J_1925446 4930546J17Rik NA NA unclassified gene RIKEN cDNA 4930546J17 gene
4 gene 147.399771 147.407631 positive MGI_C57BL6J_5826534 Gm46897 NCBI_Gene:108169016 MGI:5826534 lncRNA gene predicted gene, 46897
4 gene 147.411722 147.413457 positive MGI_C57BL6J_5826535 Gm46898 NCBI_Gene:108169017 MGI:5826535 lncRNA gene predicted gene, 46898
4 pseudogene 147.443023 147.444030 positive MGI_C57BL6J_3650656 Gm13161 NCBI_Gene:100861575,ENSEMBL:ENSMUSG00000082248 MGI:3650656 pseudogene predicted gene 13161
4 pseudogene 147.444330 147.444648 positive MGI_C57BL6J_3761374 Vmn2r-ps19 NCBI_Gene:100125283,ENSEMBL:ENSMUSG00000093975 MGI:3761374 pseudogene vomeronasal 2, receptor, pseudogene 19
4 gene 147.492417 147.513486 positive MGI_C57BL6J_3701121 Zfp982 NCBI_Gene:195531,ENSEMBL:ENSMUSG00000078496 MGI:3701121 protein coding gene zinc finger protein 982
4 pseudogene 147.520468 147.520867 negative MGI_C57BL6J_3801908 Gm15951 ENSEMBL:ENSMUSG00000081301 MGI:3801908 pseudogene predicted gene 15951
4 pseudogene 147.521521 147.521912 positive MGI_C57BL6J_3761375 Vmn2r-ps20 NCBI_Gene:100125298,ENSEMBL:ENSMUSG00000096440 MGI:3761375 pseudogene vomeronasal 2, receptor, pseudogene 20
4 pseudogene 147.527719 147.528174 negative MGI_C57BL6J_3651744 Gm13141 ENSEMBL:ENSMUSG00000082599 MGI:3651744 pseudogene predicted gene 13141
4 gene 147.540218 147.543500 positive MGI_C57BL6J_3642127 Gm16503 NA NA protein coding gene predicted gene 16503
4 gene 147.553277 147.585201 positive MGI_C57BL6J_3651986 Zfp985 NCBI_Gene:433804,ENSEMBL:ENSMUSG00000065999 MGI:3651986 protein coding gene zinc finger protein 985
4 gene 147.611936 147.642513 negative MGI_C57BL6J_2148252 Zfp979 NCBI_Gene:112422,ENSEMBL:ENSMUSG00000066000 MGI:2148252 protein coding gene zinc finger protein 979
4 pseudogene 147.624042 147.624947 negative MGI_C57BL6J_3651982 Gm13155 NCBI_Gene:666618,ENSEMBL:ENSMUSG00000096065 MGI:3651982 pseudogene predicted gene 13155
4 gene 147.668518 147.670854 negative MGI_C57BL6J_3802078 Gm16211 ENSEMBL:ENSMUSG00000086130 MGI:3802078 lncRNA gene predicted gene 16211
4 gene 147.673502 147.702631 negative MGI_C57BL6J_3650650 Zfp534 NCBI_Gene:100503584,ENSEMBL:ENSMUSG00000062518 MGI:3650650 protein coding gene zinc finger protein 534
4 pseudogene 147.732788 147.733132 positive MGI_C57BL6J_3649289 Gm13137 NCBI_Gene:666640,ENSEMBL:ENSMUSG00000096521 MGI:3649289 pseudogene predicted gene 13137
4 pseudogene 147.735250 147.738969 negative MGI_C57BL6J_3649290 Gm13136 NCBI_Gene:194189,ENSEMBL:ENSMUSG00000081179 MGI:3649290 pseudogene predicted gene 13136
4 pseudogene 147.745515 147.746561 negative MGI_C57BL6J_3651741 Gm13148 NCBI_Gene:666652,ENSEMBL:ENSMUSG00000083642 MGI:3651741 pseudogene predicted gene 13148
4 gene 147.753974 147.809788 negative MGI_C57BL6J_3651978 Zfp984 NCBI_Gene:100041677,ENSEMBL:ENSMUSG00000078495 MGI:3651978 protein coding gene zinc finger protein 984
4 gene 147.782319 147.809840 negative MGI_C57BL6J_5313154 Gm20707 ENSEMBL:ENSMUSG00000093594 MGI:5313154 lncRNA gene predicted gene 20707
4 pseudogene 147.821777 147.822202 negative MGI_C57BL6J_3701125 Rps19-ps3 NCBI_Gene:277692,ENSEMBL:ENSMUSG00000080059 MGI:3701125 pseudogene ribosomal protein S19, pseudogene 3
4 gene 147.822986 147.848461 negative MGI_C57BL6J_1922865 Zfp933 NCBI_Gene:242747,ENSEMBL:ENSMUSG00000059423 MGI:1922865 protein coding gene zinc finger protein 933
4 gene 147.860778 147.868816 negative MGI_C57BL6J_106506 Miip NCBI_Gene:28010,ENSEMBL:ENSMUSG00000029022 MGI:106506 protein coding gene migration and invasion inhibitory protein
4 gene 147.868979 147.870358 positive MGI_C57BL6J_95595 Fv1 NCBI_Gene:14349,ENSEMBL:ENSMUSG00000070583 MGI:95595 protein coding gene Friend virus susceptibility 1
4 gene 147.873586 147.904909 negative MGI_C57BL6J_2442230 Mfn2 NCBI_Gene:170731,ENSEMBL:ENSMUSG00000029020 MGI:2442230 protein coding gene mitofusin 2
4 pseudogene 147.893673 147.893993 positive MGI_C57BL6J_3651983 Gm13156 ENSEMBL:ENSMUSG00000083340 MGI:3651983 pseudogene predicted gene 13156
4 gene 147.909753 147.936776 negative MGI_C57BL6J_99907 Plod1 NCBI_Gene:18822,ENSEMBL:ENSMUSG00000019055 MGI:99907 protein coding gene procollagen-lysine, 2-oxoglutarate 5-dioxygenase 1
4 gene 147.940857 147.947316 positive MGI_C57BL6J_1924284 2510039O18Rik NCBI_Gene:77034,ENSEMBL:ENSMUSG00000044496 MGI:1924284 protein coding gene RIKEN cDNA 2510039O18 gene
4 gene 147.985773 147.987205 positive MGI_C57BL6J_97368 Nppb NCBI_Gene:18158,ENSEMBL:ENSMUSG00000029019 MGI:97368 protein coding gene natriuretic peptide type B
4 gene 148.000722 148.002079 positive MGI_C57BL6J_97367 Nppa NCBI_Gene:230899,ENSEMBL:ENSMUSG00000041616 MGI:97367 protein coding gene natriuretic peptide type A
4 gene 148.001091 148.004014 negative MGI_C57BL6J_3702728 Gm13054 ENSEMBL:ENSMUSG00000086806 MGI:3702728 lncRNA gene predicted gene 13054
4 gene 148.004259 148.038871 negative MGI_C57BL6J_1347049 Clcn6 NCBI_Gene:26372,ENSEMBL:ENSMUSG00000029016 MGI:1347049 protein coding gene chloride channel, voltage-sensitive 6
4 pseudogene 148.031554 148.032326 positive MGI_C57BL6J_3651232 Gm13207 NCBI_Gene:100418092,ENSEMBL:ENSMUSG00000083473 MGI:3651232 pseudogene predicted gene 13207
4 gene 148.038317 148.059565 positive MGI_C57BL6J_106639 Mthfr NCBI_Gene:17769,ENSEMBL:ENSMUSG00000029009 MGI:106639 protein coding gene methylenetetrahydrofolate reductase
4 gene 148.057993 148.076526 negative MGI_C57BL6J_3649941 Gm13201 NCBI_Gene:102634746,ENSEMBL:ENSMUSG00000078494 MGI:3649941 lncRNA gene predicted gene 13201
4 pseudogene 148.067962 148.068561 negative MGI_C57BL6J_3649942 Chchd2-ps NCBI_Gene:433806,ENSEMBL:ENSMUSG00000094320 MGI:3649942 pseudogene coiled-coil-helix-coiled-coil-helix domain containing 2, pseudogene
4 gene 148.077061 148.088064 negative MGI_C57BL6J_1339977 Agtrap NCBI_Gene:11610,ENSEMBL:ENSMUSG00000029007 MGI:1339977 protein coding gene angiotensin II, type I receptor-associated protein
4 gene 148.098437 148.131055 negative MGI_C57BL6J_1917683 Draxin NCBI_Gene:70433,ENSEMBL:ENSMUSG00000029005 MGI:1917683 protein coding gene dorsal inhibitory axon guidance protein
4 gene 148.130255 148.145704 positive MGI_C57BL6J_1919140 Mad2l2 NCBI_Gene:71890,ENSEMBL:ENSMUSG00000029003 MGI:1919140 protein coding gene MAD2 mitotic arrest deficient-like 2
4 gene 148.145716 148.152140 negative MGI_C57BL6J_1354743 Fbxo6 NCBI_Gene:50762,ENSEMBL:ENSMUSG00000055401 MGI:1354743 protein coding gene F-box protein 6
4 gene 148.146936 148.146996 negative MGI_C57BL6J_5530673 Mir7022 miRBase:MI0022871,NCBI_Gene:102465619,ENSEMBL:ENSMUSG00000099043 MGI:5530673 miRNA gene microRNA 7022
4 gene 148.152799 148.160482 negative MGI_C57BL6J_1354744 Fbxo44 NCBI_Gene:230903,ENSEMBL:ENSMUSG00000029001 MGI:1354744 protein coding gene F-box protein 44
4 gene 148.160204 148.166424 positive MGI_C57BL6J_2446216 Fbxo2 NCBI_Gene:230904,ENSEMBL:ENSMUSG00000041556 MGI:2446216 protein coding gene F-box protein 2
4 gene 148.208113 148.214764 negative MGI_C57BL6J_5591762 Gm32603 NCBI_Gene:102635206 MGI:5591762 lncRNA gene predicted gene, 32603
4 gene 148.236433 148.287965 negative MGI_C57BL6J_2444403 Disp3 NCBI_Gene:242748,ENSEMBL:ENSMUSG00000041544 MGI:2444403 protein coding gene dispatched RND transporter family member 3
4 gene 148.306853 148.316569 positive MGI_C57BL6J_3651440 Gm13206 ENSEMBL:ENSMUSG00000087027 MGI:3651440 lncRNA gene predicted gene 13206
4 gene 148.356379 148.359460 negative MGI_C57BL6J_3650195 Gm13200 ENSEMBL:ENSMUSG00000086326 MGI:3650195 lncRNA gene predicted gene 13200
4 gene 148.434495 148.444771 negative MGI_C57BL6J_1918957 Ubiad1 NCBI_Gene:71707,ENSEMBL:ENSMUSG00000047719 MGI:1918957 protein coding gene UbiA prenyltransferase domain containing 1
4 gene 148.443334 148.443485 negative MGI_C57BL6J_5453080 Gm23303 ENSEMBL:ENSMUSG00000064648 MGI:5453080 snRNA gene predicted gene, 23303
4 gene 148.448582 148.557685 positive MGI_C57BL6J_1928394 Mtor NCBI_Gene:56717,ENSEMBL:ENSMUSG00000028991 MGI:1928394 protein coding gene mechanistic target of rapamycin kinase
4 gene 148.495181 148.500462 negative MGI_C57BL6J_3605801 Angptl7 NCBI_Gene:654812,ENSEMBL:ENSMUSG00000028989 MGI:3605801 protein coding gene angiopoietin-like 7
4 gene 148.539127 148.539230 positive MGI_C57BL6J_5453779 Gm24002 ENSEMBL:ENSMUSG00000089081 MGI:5453779 snRNA gene predicted gene, 24002
4 gene 148.555697 148.555804 positive MGI_C57BL6J_5453095 Gm23318 ENSEMBL:ENSMUSG00000088625 MGI:5453095 snRNA gene predicted gene, 23318
4 gene 148.558422 148.582401 positive MGI_C57BL6J_1355322 Exosc10 NCBI_Gene:50912,ENSEMBL:ENSMUSG00000017264 MGI:1355322 protein coding gene exosome component 10
4 pseudogene 148.569056 148.569876 negative MGI_C57BL6J_3651444 Gm13204 ENSEMBL:ENSMUSG00000082860 MGI:3651444 pseudogene predicted gene 13204
4 gene 148.584721 148.586007 negative MGI_C57BL6J_3651228 Gm13209 ENSEMBL:ENSMUSG00000087217 MGI:3651228 lncRNA gene predicted gene 13209
4 gene 148.591503 148.594993 positive MGI_C57BL6J_102690 Srm NCBI_Gene:20810,ENSEMBL:ENSMUSG00000006442 MGI:102690 protein coding gene spermidine synthase
4 gene 148.594904 148.615499 positive MGI_C57BL6J_1330832 Masp2 NCBI_Gene:17175,ENSEMBL:ENSMUSG00000028979 MGI:1330832 protein coding gene mannan-binding lectin serine peptidase 2
4 gene 148.612382 148.627019 negative MGI_C57BL6J_2387629 Tardbp NCBI_Gene:230908,ENSEMBL:ENSMUSG00000041459 MGI:2387629 protein coding gene TAR DNA binding protein
4 gene 148.643317 148.676969 positive MGI_C57BL6J_2685418 Gm572 NCBI_Gene:230909,ENSEMBL:ENSMUSG00000070577 MGI:2685418 protein coding gene predicted gene 572
4 gene 148.713703 148.716581 positive MGI_C57BL6J_3651445 Gm13203 ENSEMBL:ENSMUSG00000087273 MGI:3651445 lncRNA gene predicted gene 13203
4 gene 148.744903 148.747395 negative MGI_C57BL6J_5592056 Gm32897 NCBI_Gene:102635606 MGI:5592056 lncRNA gene predicted gene, 32897
4 gene 148.779750 148.784880 negative MGI_C57BL6J_5625235 Gm42350 NCBI_Gene:105247212 MGI:5625235 lncRNA gene predicted gene, 42350
4 gene 148.804367 148.954893 positive MGI_C57BL6J_1196251 Casz1 NCBI_Gene:69743,ENSEMBL:ENSMUSG00000028977 MGI:1196251 protein coding gene castor zinc finger 1
4 gene 148.865117 148.867483 negative MGI_C57BL6J_5625237 Gm42352 NCBI_Gene:105247214 MGI:5625237 lncRNA gene predicted gene, 42352
4 gene 148.913511 148.914324 negative MGI_C57BL6J_3801757 Gm15969 ENSEMBL:ENSMUSG00000086766 MGI:3801757 lncRNA gene predicted gene 15969
4 gene 148.947487 148.949731 negative MGI_C57BL6J_3700976 Gm13205 NCBI_Gene:108168987,ENSEMBL:ENSMUSG00000086606 MGI:3700976 lncRNA gene predicted gene 13205
4 gene 148.957491 148.991926 positive MGI_C57BL6J_4937856 Gm17029 NCBI_Gene:102635786,ENSEMBL:ENSMUSG00000086740 MGI:4937856 lncRNA gene predicted gene 17029
4 gene 148.960535 149.099876 negative MGI_C57BL6J_1927868 Pex14 NCBI_Gene:56273,ENSEMBL:ENSMUSG00000028975 MGI:1927868 protein coding gene peroxisomal biogenesis factor 14
4 gene 148.997016 149.003006 negative MGI_C57BL6J_5625236 Gm42351 NCBI_Gene:105247213 MGI:5625236 lncRNA gene predicted gene, 42351
4 pseudogene 149.096334 149.096881 positive MGI_C57BL6J_3779916 Gm9506 NCBI_Gene:670864,ENSEMBL:ENSMUSG00000081086 MGI:3779916 pseudogene predicted gene 9506
4 gene 149.098924 149.099819 positive MGI_C57BL6J_5826359 Gm46722 NCBI_Gene:108168707 MGI:5826359 lncRNA gene predicted gene, 46722
4 gene 149.104142 149.120653 positive MGI_C57BL6J_1196227 Dffa NCBI_Gene:13347,ENSEMBL:ENSMUSG00000028974 MGI:1196227 protein coding gene DNA fragmentation factor, alpha subunit
4 gene 149.125034 149.126763 negative MGI_C57BL6J_109538 Cort NCBI_Gene:12854,ENSEMBL:ENSMUSG00000028971 MGI:109538 protein coding gene cortistatin
4 gene 149.127121 149.137629 negative MGI_C57BL6J_1917178 Cenps NCBI_Gene:69928,ENSEMBL:ENSMUSG00000073705 MGI:1917178 protein coding gene centromere protein S
4 pseudogene 149.142432 149.143465 negative MGI_C57BL6J_3651234 Rpsa-ps12 NCBI_Gene:666774,ENSEMBL:ENSMUSG00000080746 MGI:3651234 pseudogene ribosomal protein SA, pseudogene 12
4 gene 149.149985 149.166771 negative MGI_C57BL6J_97553 Pgd NCBI_Gene:110208,ENSEMBL:ENSMUSG00000028961 MGI:97553 protein coding gene phosphogluconate dehydrogenase
4 gene 149.176319 149.307733 negative MGI_C57BL6J_108426 Kif1b NCBI_Gene:16561,ENSEMBL:ENSMUSG00000063077 MGI:108426 protein coding gene kinesin family member 1B
4 gene 149.255154 149.256712 negative MGI_C57BL6J_3026951 6720462K09Rik NA NA unclassified gene RIKEN cDNA 6720462K09 gene
4 gene 149.328416 149.426749 negative MGI_C57BL6J_1927086 Ube4b NCBI_Gene:63958,ENSEMBL:ENSMUSG00000028960 MGI:1927086 protein coding gene ubiquitination factor E4B
4 gene 149.334639 149.335912 positive MGI_C57BL6J_1921560 Ube4bos3 NCBI_Gene:74310,ENSEMBL:ENSMUSG00000085286 MGI:1921560 antisense lncRNA gene ubiquitination factor E4B, opposite strand 3
4 gene 149.338087 149.338531 positive MGI_C57BL6J_3651969 Ube4bos2 ENSEMBL:ENSMUSG00000085807 MGI:3651969 antisense lncRNA gene ubiquitination factor E4B, opposite strand 2
4 gene 149.347885 149.365277 positive MGI_C57BL6J_1925072 Ube4bos1 ENSEMBL:ENSMUSG00000085819 MGI:1925072 antisense lncRNA gene ubiquitination factor E4B, opposite strand 1
4 gene 149.449687 149.466462 negative MGI_C57BL6J_1890409 Rbp7 NCBI_Gene:63954,ENSEMBL:ENSMUSG00000028996 MGI:1890409 protein coding gene retinol binding protein 7, cellular
4 pseudogene 149.457288 149.457889 positive MGI_C57BL6J_3651720 Trmt112-ps2 NCBI_Gene:627985,ENSEMBL:ENSMUSG00000070572 MGI:3651720 pseudogene tRNA methyltransferase 11-2, pseudogene 2
4 gene 149.467572 149.485202 negative MGI_C57BL6J_1913704 Nmnat1 NCBI_Gene:66454,ENSEMBL:ENSMUSG00000028992 MGI:1913704 protein coding gene nicotinamide nucleotide adenylyltransferase 1
4 gene 149.477378 149.484265 positive MGI_C57BL6J_3701129 Tmem274 NCBI_Gene:102636051,ENSEMBL:ENSMUSG00000087198 MGI:3701129 protein coding gene transmembrame protein 274
4 gene 149.485205 149.496668 positive MGI_C57BL6J_1916401 Lzic NCBI_Gene:69151,ENSEMBL:ENSMUSG00000028990 MGI:1916401 protein coding gene leucine zipper and CTNNBIP1 domain containing
4 pseudogene 149.500633 149.501008 positive MGI_C57BL6J_3651971 Gm13071 ENSEMBL:ENSMUSG00000083811 MGI:3651971 pseudogene predicted gene 13071
4 gene 149.504663 149.505241 positive MGI_C57BL6J_1920314 2900080M03Rik NA NA unclassified gene RIKEN cDNA 2900080M03 gene
4 gene 149.517179 149.517282 negative MGI_C57BL6J_5454158 Gm24381 ENSEMBL:ENSMUSG00000084646 MGI:5454158 snRNA gene predicted gene, 24381
4 gene 149.518236 149.566437 positive MGI_C57BL6J_1915756 Ctnnbip1 NCBI_Gene:67087,ENSEMBL:ENSMUSG00000028988 MGI:1915756 protein coding gene catenin beta interacting protein 1
4 gene 149.537863 149.537922 positive MGI_C57BL6J_5454968 Mir5616 miRBase:MI0019184,NCBI_Gene:100885828,ENSEMBL:ENSMUSG00000093403 MGI:5454968 miRNA gene microRNA 5616
4 gene 149.565620 149.567790 negative MGI_C57BL6J_3701131 Gm13066 ENSEMBL:ENSMUSG00000086949 MGI:3701131 lncRNA gene predicted gene 13066
4 gene 149.572733 149.573993 positive MGI_C57BL6J_1925218 A930041D05Rik NA NA unclassified gene RIKEN cDNA A930041D05 gene
4 gene 149.586468 149.648899 positive MGI_C57BL6J_1929895 Clstn1 NCBI_Gene:65945,ENSEMBL:ENSMUSG00000039953 MGI:1929895 protein coding gene calsyntenin 1
4 gene 149.649168 149.702571 negative MGI_C57BL6J_1098211 Pik3cd NCBI_Gene:18707,ENSEMBL:ENSMUSG00000039936 MGI:1098211 protein coding gene phosphatidylinositol-4,5-bisphosphate 3-kinase catalytic subunit delta
4 gene 149.655504 149.655567 negative MGI_C57BL6J_5531294 Mir7023 miRBase:MI0022872,NCBI_Gene:102465983,ENSEMBL:ENSMUSG00000098580 MGI:5531294 miRNA gene microRNA 7023
4 gene 149.715375 149.738073 negative MGI_C57BL6J_1196277 Tmem201 NCBI_Gene:230917,ENSEMBL:ENSMUSG00000044700 MGI:1196277 protein coding gene transmembrane protein 201
4 gene 149.744036 149.774277 negative MGI_C57BL6J_1917806 Slc25a33 NCBI_Gene:70556,ENSEMBL:ENSMUSG00000028982 MGI:1917806 protein coding gene solute carrier family 25, member 33
4 gene 149.748518 149.749607 positive MGI_C57BL6J_3651967 Gm13068 ENSEMBL:ENSMUSG00000085403 MGI:3651967 lncRNA gene predicted gene 13068
4 gene 149.776252 149.783332 positive MGI_C57BL6J_3802067 Gm16188 ENSEMBL:ENSMUSG00000085368 MGI:3802067 lncRNA gene predicted gene 16188
4 gene 149.778380 149.780997 negative MGI_C57BL6J_3651721 Gm13073 NCBI_Gene:105247217,ENSEMBL:ENSMUSG00000084807 MGI:3651721 lncRNA gene predicted gene 13073
4 gene 149.790691 149.802529 positive MGI_C57BL6J_5625239 Gm42354 NCBI_Gene:105247218 MGI:5625239 lncRNA gene predicted gene, 42354
4 pseudogene 149.793279 149.793419 negative MGI_C57BL6J_3651736 Gm13065 ENSEMBL:ENSMUSG00000081601 MGI:3651736 pseudogene predicted gene 13065
4 pseudogene 149.814666 149.815222 negative MGI_C57BL6J_3651735 Gm13064 ENSEMBL:ENSMUSG00000083173 MGI:3651735 pseudogene predicted gene 13064
4 gene 149.817732 149.817840 positive MGI_C57BL6J_4422058 n-R5s193 ENSEMBL:ENSMUSG00000064798 MGI:4422058 rRNA gene nuclear encoded rRNA 5S 193
4 gene 149.817764 149.817823 positive MGI_C57BL6J_6096167 Gm47301 ENSEMBL:ENSMUSG00000106221 MGI:6096167 miRNA gene predicted gene, 47301
4 gene 149.896283 149.955043 negative MGI_C57BL6J_1921896 Spsb1 NCBI_Gene:74646,ENSEMBL:ENSMUSG00000039911 MGI:1921896 protein coding gene splA/ryanodine receptor domain and SOCS box containing 1
4 gene 149.902058 149.908149 positive MGI_C57BL6J_3651970 Gm13070 NCBI_Gene:105247219,ENSEMBL:ENSMUSG00000086767 MGI:3651970 lncRNA gene predicted gene 13070
4 gene 149.979474 150.009023 negative MGI_C57BL6J_2140356 H6pd NCBI_Gene:100198,ENSEMBL:ENSMUSG00000028980 MGI:2140356 protein coding gene hexose-6-phosphate dehydrogenase (glucose 1-dehydrogenase)
4 gene 150.029405 150.058717 positive MGI_C57BL6J_3651968 Gm13067 NCBI_Gene:102636131,ENSEMBL:ENSMUSG00000086665 MGI:3651968 lncRNA gene predicted gene 13067
4 gene 150.068454 150.068555 positive MGI_C57BL6J_3619363 Mir34a miRBase:MI0000584,NCBI_Gene:723848,ENSEMBL:ENSMUSG00000065493 MGI:3619363 miRNA gene microRNA 34a
4 gene 150.068539 150.070997 positive MGI_C57BL6J_5611023 Gm37795 ENSEMBL:ENSMUSG00000102813 MGI:5611023 unclassified gene predicted gene, 37795
4 gene 150.087365 150.105927 positive MGI_C57BL6J_2442046 Gpr157 NCBI_Gene:269604,ENSEMBL:ENSMUSG00000047875 MGI:2442046 protein coding gene G protein-coupled receptor 157
4 gene 150.113879 150.119263 negative MGI_C57BL6J_3650866 Gm13093 ENSEMBL:ENSMUSG00000087094 MGI:3650866 lncRNA gene predicted gene 13093
4 gene 150.119276 150.144169 positive MGI_C57BL6J_1928369 Slc2a5 NCBI_Gene:56485,ENSEMBL:ENSMUSG00000028976 MGI:1928369 protein coding gene solute carrier family 2 (facilitated glucose transporter), member 5
4 gene 150.148834 150.168896 positive MGI_C57BL6J_3650865 Slc2a7 NCBI_Gene:435818,ENSEMBL:ENSMUSG00000062064 MGI:3650865 protein coding gene solute carrier family 2 (facilitated glucose transporter), member 7
4 gene 150.187015 150.201332 negative MGI_C57BL6J_1333786 Car6 NCBI_Gene:12353,ENSEMBL:ENSMUSG00000028972 MGI:1333786 protein coding gene carbonic anhydrase 6
4 pseudogene 150.228035 150.228443 positive MGI_C57BL6J_3650867 Gm13094 ENSEMBL:ENSMUSG00000082140 MGI:3650867 pseudogene predicted gene 13094
4 gene 150.236721 150.248879 positive MGI_C57BL6J_95393 Eno1 NCBI_Gene:13806,ENSEMBL:ENSMUSG00000063524 MGI:95393 protein coding gene enolase 1, alpha non-neuron
4 gene 150.259210 150.262905 positive MGI_C57BL6J_5592574 Gm33415 NCBI_Gene:102636312 MGI:5592574 lncRNA gene predicted gene, 33415
4 gene 150.281550 150.621966 positive MGI_C57BL6J_2683486 Rere NCBI_Gene:68703,ENSEMBL:ENSMUSG00000039852 MGI:2683486 protein coding gene arginine glutamic acid dipeptide (RE) repeats
4 pseudogene 150.315147 150.315616 negative MGI_C57BL6J_3649661 Gm13092 NCBI_Gene:102638183,ENSEMBL:ENSMUSG00000085787 MGI:3649661 pseudogene predicted gene 13092
4 gene 150.321193 150.321302 positive MGI_C57BL6J_5452986 Gm23209 ENSEMBL:ENSMUSG00000089292 MGI:5452986 snRNA gene predicted gene, 23209
4 gene 150.328703 150.334151 positive MGI_C57BL6J_2443638 D030004A10Rik NA NA unclassified gene RIKEN cDNA D030004A10 gene
4 gene 150.416263 150.418019 positive MGI_C57BL6J_2442500 E230012J19Rik NA NA unclassified gene RIKEN cDNA E230012J19 gene
4 gene 150.478019 150.480171 positive MGI_C57BL6J_2442856 9430064G09Rik NA NA unclassified gene RIKEN cDNA 9430064G09 gene
4 gene 150.511945 150.516396 positive MGI_C57BL6J_5625240 Gm42355 NCBI_Gene:105247220 MGI:5625240 protein coding gene predicted gene, 42355
4 gene 150.566869 150.568544 negative MGI_C57BL6J_3649653 Gm13091 ENSEMBL:ENSMUSG00000085213 MGI:3649653 lncRNA gene predicted gene 13091
4 gene 150.628572 150.652174 negative MGI_C57BL6J_2653235 Slc45a1 NCBI_Gene:242773,ENSEMBL:ENSMUSG00000039838 MGI:2653235 protein coding gene solute carrier family 45, member 1
4 gene 150.668248 150.678792 negative MGI_C57BL6J_3802017 Gm16079 ENSEMBL:ENSMUSG00000085869 MGI:3802017 lncRNA gene predicted gene 16079
4 gene 150.704548 150.739130 positive MGI_C57BL6J_5595759 Gm36600 NCBI_Gene:102640566 MGI:5595759 lncRNA gene predicted gene, 36600
4 gene 150.776226 150.818152 negative MGI_C57BL6J_5595965 Gm36806 NCBI_Gene:102640831 MGI:5595965 lncRNA gene predicted gene, 36806
4 gene 150.807722 150.809721 positive MGI_C57BL6J_5625241 Gm42356 NCBI_Gene:105247221 MGI:5625241 lncRNA gene predicted gene, 42356
4 gene 150.825733 150.839575 positive MGI_C57BL6J_3650887 Gm13049 ENSEMBL:ENSMUSG00000085097 MGI:3650887 lncRNA gene predicted gene 13049
4 gene 150.828225 150.854949 negative MGI_C57BL6J_1920598 1700045H11Rik NCBI_Gene:73348,ENSEMBL:ENSMUSG00000078492 MGI:1920598 lncRNA gene RIKEN cDNA 1700045H11 gene
4 pseudogene 150.847052 150.847541 positive MGI_C57BL6J_3650886 Rps15a-ps3 NCBI_Gene:108168715,ENSEMBL:ENSMUSG00000084314 MGI:3650886 pseudogene ribosomal protein S15A, pseudogene 3
4 gene 150.853801 150.868892 positive MGI_C57BL6J_1921405 Errfi1 NCBI_Gene:74155,ENSEMBL:ENSMUSG00000028967 MGI:1921405 protein coding gene ERBB receptor feedback inhibitor 1
4 gene 150.897133 150.914437 negative MGI_C57BL6J_2135637 Park7 NCBI_Gene:57320,ENSEMBL:ENSMUSG00000028964 MGI:2135637 protein coding gene Parkinson disease (autosomal recessive, early onset) 7
4 gene 150.914562 150.946104 positive MGI_C57BL6J_1101059 Tnfrsf9 NCBI_Gene:21942,ENSEMBL:ENSMUSG00000028965 MGI:1101059 protein coding gene tumor necrosis factor receptor superfamily, member 9
4 gene 150.917322 151.861876 negative MGI_C57BL6J_2140230 Camta1 NCBI_Gene:100072,ENSEMBL:ENSMUSG00000014592 MGI:2140230 protein coding gene calmodulin binding transcription activator 1
4 gene 150.964735 150.964894 positive MGI_C57BL6J_5453182 Gm23405 ENSEMBL:ENSMUSG00000064476 MGI:5453182 snRNA gene predicted gene, 23405
4 gene 150.965587 150.980888 negative MGI_C57BL6J_5589279 Gm30120 NCBI_Gene:102631903 MGI:5589279 lncRNA gene predicted gene, 30120
4 gene 150.978643 150.979963 negative MGI_C57BL6J_1924312 5330422M15Rik NA NA unclassified gene RIKEN cDNA 5330422M15 gene
4 gene 150.997018 151.044723 negative MGI_C57BL6J_1277134 Per3 NCBI_Gene:18628,ENSEMBL:ENSMUSG00000028957 MGI:1277134 protein coding gene period circadian clock 3
4 gene 150.997097 151.001810 positive MGI_C57BL6J_1346329 Uts2 NCBI_Gene:24111,ENSEMBL:ENSMUSG00000028963 MGI:1346329 protein coding gene urotensin 2
4 gene 151.044820 151.059056 positive MGI_C57BL6J_5621414 Gm38529 NCBI_Gene:102641068 MGI:5621414 protein coding gene predicted gene, 38529
4 gene 151.047300 151.057963 negative MGI_C57BL6J_1321389 Vamp3 NCBI_Gene:22319,ENSEMBL:ENSMUSG00000028955 MGI:1321389 protein coding gene vesicle-associated membrane protein 3
4 gene 151.088988 151.091790 positive MGI_C57BL6J_3650445 Gm13090 NCBI_Gene:105704528,ENSEMBL:ENSMUSG00000078491 MGI:3650445 protein coding gene predicted gene 13090
4 gene 151.093361 151.105732 positive MGI_C57BL6J_5826536 Gm46899 NCBI_Gene:108169018 MGI:5826536 lncRNA gene predicted gene, 46899
4 gene 151.216029 151.222340 positive MGI_C57BL6J_5589581 Gm30422 NCBI_Gene:102632317 MGI:5589581 lncRNA gene predicted gene, 30422
4 gene 151.222397 151.233428 positive MGI_C57BL6J_5825597 Gm45960 NCBI_Gene:108167361 MGI:5825597 lncRNA gene predicted gene, 45960
4 gene 151.376470 151.379582 positive MGI_C57BL6J_1914998 4930589P08Rik ENSEMBL:ENSMUSG00000085593 MGI:1914998 lncRNA gene RIKEN cDNA 4930589P08 gene
4 gene 151.455152 151.457744 positive MGI_C57BL6J_5589503 Gm30344 NCBI_Gene:102632204 MGI:5589503 lncRNA gene predicted gene, 30344
4 gene 151.638629 151.723298 negative MGI_C57BL6J_5621327 Gm38442 NCBI_Gene:102632096 MGI:5621327 lncRNA gene predicted gene, 38442
4 gene 151.840553 151.867789 positive MGI_C57BL6J_5625242 Gm42357 NCBI_Gene:105247222 MGI:5625242 lncRNA gene predicted gene, 42357
4 gene 151.862339 151.863311 positive MGI_C57BL6J_1925157 9230110K08Rik NCBI_Gene:102631977 MGI:1925157 lncRNA gene RIKEN cDNA 9230110K08 gene
4 gene 151.915993 151.916414 negative MGI_C57BL6J_5610369 Gm37141 ENSEMBL:ENSMUSG00000104142 MGI:5610369 unclassified gene predicted gene, 37141
4 gene 151.932378 151.932851 negative MGI_C57BL6J_1920975 1110001D16Rik NA NA unclassified gene RIKEN cDNA 1110001D16 gene
4 gene 151.933691 151.982137 positive MGI_C57BL6J_2443386 Dnajc11 NCBI_Gene:230935,ENSEMBL:ENSMUSG00000039768 MGI:2443386 protein coding gene DnaJ heat shock protein family (Hsp40) member C11
4 gene 151.982638 151.988997 negative MGI_C57BL6J_1917126 Thap3 NCBI_Gene:69876,ENSEMBL:ENSMUSG00000039759 MGI:1917126 protein coding gene THAP domain containing, apoptosis associated protein 3
4 gene 151.989631 151.996258 negative MGI_C57BL6J_2446217 Phf13 NCBI_Gene:230936,ENSEMBL:ENSMUSG00000047777 MGI:2446217 protein coding gene PHD finger protein 13
4 gene 152.006759 152.009619 negative MGI_C57BL6J_3704239 Gm9768 ENSEMBL:ENSMUSG00000108391 MGI:3704239 unclassified gene predicted gene 9768
4 gene 152.008803 152.017680 positive MGI_C57BL6J_1919288 Klhl21 NCBI_Gene:242785,ENSEMBL:ENSMUSG00000073700 MGI:1919288 protein coding gene kelch-like 21
4 gene 152.019773 152.027671 negative MGI_C57BL6J_2140248 Zbtb48 NCBI_Gene:100090,ENSEMBL:ENSMUSG00000028952 MGI:2140248 protein coding gene zinc finger and BTB domain containing 48
4 gene 152.027914 152.038568 negative MGI_C57BL6J_1927505 Tas1r1 NCBI_Gene:110326,ENSEMBL:ENSMUSG00000028950 MGI:1927505 protein coding gene taste receptor, type 1, member 1
4 gene 152.039238 152.061494 positive MGI_C57BL6J_1921285 Nol9 NCBI_Gene:74035,ENSEMBL:ENSMUSG00000028948 MGI:1921285 protein coding gene nucleolar protein 9
4 gene 152.072433 152.115404 positive MGI_C57BL6J_2652860 Plekhg5 NCBI_Gene:269608,ENSEMBL:ENSMUSG00000039713 MGI:2652860 protein coding gene pleckstrin homology domain containing, family G (with RhoGef domain) member 5
4 gene 152.115528 152.120119 positive MGI_C57BL6J_1934667 Tnfrsf25 NCBI_Gene:85030,ENSEMBL:ENSMUSG00000024793 MGI:1934667 protein coding gene tumor necrosis factor receptor superfamily, member 25
4 gene 152.120331 152.152420 negative MGI_C57BL6J_1861630 Espn NCBI_Gene:56226,ENSEMBL:ENSMUSG00000028943 MGI:1861630 protein coding gene espin
4 pseudogene 152.125114 152.126863 negative MGI_C57BL6J_5010037 Gm17852 NCBI_Gene:100415981 MGI:5010037 pseudogene predicted gene, 17852
4 pseudogene 152.156049 152.157564 negative MGI_C57BL6J_3649703 Gm13077 NCBI_Gene:100504731,ENSEMBL:ENSMUSG00000081544 MGI:3649703 pseudogene predicted gene 13077
4 gene 152.158867 152.162469 positive MGI_C57BL6J_1098624 Hes2 NCBI_Gene:15206,ENSEMBL:ENSMUSG00000028940 MGI:1098624 protein coding gene hes family bHLH transcription factor 2
4 gene 152.163762 152.166419 positive MGI_C57BL6J_5589781 Gm30622 NCBI_Gene:102632584 MGI:5589781 lncRNA gene predicted gene, 30622
4 gene 152.178100 152.271855 positive MGI_C57BL6J_1917275 Acot7 NCBI_Gene:70025,ENSEMBL:ENSMUSG00000028937 MGI:1917275 protein coding gene acyl-CoA thioesterase 7
4 gene 152.201807 152.202142 negative MGI_C57BL6J_5530882 Gm27500 ENSEMBL:ENSMUSG00000098385 MGI:5530882 unclassified non-coding RNA gene predicted gene, 27500
4 gene 152.203926 152.204467 positive MGI_C57BL6J_3649461 Gm13096 ENSEMBL:ENSMUSG00000085724 MGI:3649461 lncRNA gene predicted gene 13096
4 gene 152.273938 152.285343 positive MGI_C57BL6J_1916157 Gpr153 NCBI_Gene:100129,ENSEMBL:ENSMUSG00000042804 MGI:1916157 protein coding gene G protein-coupled receptor 153
4 gene 152.285965 152.291910 negative MGI_C57BL6J_104877 Hes3 NCBI_Gene:15207,ENSEMBL:ENSMUSG00000028946 MGI:104877 protein coding gene hes family bHLH transcription factor 3
4 gene 152.297214 152.307126 positive MGI_C57BL6J_1888594 Icmt NCBI_Gene:57295,ENSEMBL:ENSMUSG00000039662 MGI:1888594 protein coding gene isoprenylcysteine carboxyl methyltransferase
4 gene 152.307018 152.319369 negative MGI_C57BL6J_2684989 Rnf207 NCBI_Gene:433809,ENSEMBL:ENSMUSG00000058498 MGI:2684989 protein coding gene ring finger protein 207
4 gene 152.321318 152.324725 negative MGI_C57BL6J_2445197 9430083M05Rik NCBI_Gene:102632664 MGI:2445197 lncRNA gene RIKEN cDNA 9430083M05 gene
4 gene 152.324436 152.334082 positive MGI_C57BL6J_99262 Rpl22 NCBI_Gene:19934,ENSEMBL:ENSMUSG00000028936 MGI:99262 protein coding gene ribosomal protein L22
4 gene 152.338651 152.390194 positive MGI_C57BL6J_3036258 Chd5 NCBI_Gene:269610,ENSEMBL:ENSMUSG00000005045 MGI:3036258 protein coding gene chromodomain helicase DNA binding protein 5
4 gene 152.352198 152.353641 negative MGI_C57BL6J_3650945 Gm13645 ENSEMBL:ENSMUSG00000085179 MGI:3650945 lncRNA gene predicted gene 13645
4 gene 152.390740 152.477910 negative MGI_C57BL6J_109239 Kcnab2 NCBI_Gene:16498,ENSEMBL:ENSMUSG00000028931 MGI:109239 protein coding gene potassium voltage-gated channel, shaker-related subfamily, beta member 2
4 gene 152.410800 152.411262 positive MGI_C57BL6J_3840150 Gm16333 ENSEMBL:ENSMUSG00000090057 MGI:3840150 lncRNA gene predicted gene 16333
4 gene 152.473880 152.563184 positive MGI_C57BL6J_2384210 Nphp4 NCBI_Gene:260305,ENSEMBL:ENSMUSG00000039577 MGI:2384210 protein coding gene nephronophthisis 4 (juvenile) homolog (human)
4 gene 152.580818 152.583635 negative MGI_C57BL6J_5589893 Gm30734 NCBI_Gene:102632740 MGI:5589893 lncRNA gene predicted gene, 30734
4 pseudogene 152.677426 152.678003 negative MGI_C57BL6J_3650871 Gm13172 NCBI_Gene:667039,ENSEMBL:ENSMUSG00000083078 MGI:3650871 pseudogene predicted gene 13172
4 gene 152.697540 152.700922 positive MGI_C57BL6J_2685679 Gm833 NCBI_Gene:330004,ENSEMBL:ENSMUSG00000073699 MGI:2685679 lncRNA gene predicted gene 833
4 gene 152.762770 152.772326 positive MGI_C57BL6J_5590010 Gm30851 NCBI_Gene:102632895 MGI:5590010 lncRNA gene predicted gene, 30851
4 gene 152.851543 152.859293 negative MGI_C57BL6J_5590070 Gm30911 NCBI_Gene:102632969 MGI:5590070 lncRNA gene predicted gene, 30911
4 gene 153.013490 153.013584 negative MGI_C57BL6J_5455556 Gm25779 ENSEMBL:ENSMUSG00000080360 MGI:5455556 miRNA gene predicted gene, 25779
4 gene 153.145590 153.146943 negative MGI_C57BL6J_3650870 Gm13173 ENSEMBL:ENSMUSG00000085648 MGI:3650870 lncRNA gene predicted gene 13173
4 gene 153.148289 153.165127 negative MGI_C57BL6J_5590214 Gm31055 NCBI_Gene:102633157 MGI:5590214 lncRNA gene predicted gene, 31055
4 gene 153.218176 153.218595 positive MGI_C57BL6J_3650869 Gm13174 ENSEMBL:ENSMUSG00000087454 MGI:3650869 lncRNA gene predicted gene 13174
4 gene 153.373221 153.485578 negative MGI_C57BL6J_2685419 Ajap1 NCBI_Gene:230959,ENSEMBL:ENSMUSG00000039546 MGI:2685419 protein coding gene adherens junction associated protein 1
4 gene 153.496714 153.498960 negative MGI_C57BL6J_5625243 Gm42358 NCBI_Gene:105247223 MGI:5625243 lncRNA gene predicted gene, 42358
4 gene 153.518919 153.548034 negative MGI_C57BL6J_5625244 Gm42359 NCBI_Gene:105247224 MGI:5625244 lncRNA gene predicted gene, 42359
4 gene 153.554533 153.558250 negative MGI_C57BL6J_5590277 Gm31118 NCBI_Gene:102633243 MGI:5590277 lncRNA gene predicted gene, 31118
4 gene 153.585677 153.586237 positive MGI_C57BL6J_5590339 Gm31180 NCBI_Gene:102633329 MGI:5590339 lncRNA gene predicted gene, 31180
4 gene 153.612441 153.618186 negative MGI_C57BL6J_5625245 Gm42360 NCBI_Gene:105247225 MGI:5625245 lncRNA gene predicted gene, 42360
4 gene 153.798547 153.802226 negative MGI_C57BL6J_5590398 Gm31239 NCBI_Gene:102633405 MGI:5590398 lncRNA gene predicted gene, 31239
4 gene 153.834513 153.841765 negative MGI_C57BL6J_5590512 Gm31353 NCBI_Gene:102633557 MGI:5590512 lncRNA gene predicted gene, 31353
4 gene 153.876384 153.876515 positive MGI_C57BL6J_5455657 Gm25880 ENSEMBL:ENSMUSG00000077519 MGI:5455657 snoRNA gene predicted gene, 25880
4 gene 153.907386 153.908666 positive MGI_C57BL6J_3649445 Gm13115 ENSEMBL:ENSMUSG00000085390 MGI:3649445 lncRNA gene predicted gene 13115
4 gene 153.947633 153.950503 negative MGI_C57BL6J_3039570 BC039966 NCBI_Gene:407793,ENSEMBL:ENSMUSG00000086272 MGI:3039570 lncRNA gene cDNA sequence BC039966
4 gene 153.956760 153.957173 negative MGI_C57BL6J_3039640 BC049688 NA NA unclassified non-coding RNA gene cDNA sequence BC049688
4 gene 153.957237 153.961925 positive MGI_C57BL6J_2140680 A430005L14Rik NCBI_Gene:97159,ENSEMBL:ENSMUSG00000047613 MGI:2140680 protein coding gene RIKEN cDNA A430005L14 gene
4 gene 153.964447 153.975126 negative MGI_C57BL6J_1196287 Dffb NCBI_Gene:13368,ENSEMBL:ENSMUSG00000029027 MGI:1196287 protein coding gene DNA fragmentation factor, beta subunit
4 gene 153.975126 154.008732 positive MGI_C57BL6J_2687282 Cep104 NCBI_Gene:230967,ENSEMBL:ENSMUSG00000039523 MGI:2687282 protein coding gene centrosomal protein 104
4 gene 153.985480 153.988488 negative MGI_C57BL6J_5625246 Gm42361 NCBI_Gene:105247226 MGI:5625246 lncRNA gene predicted gene, 42361
4 gene 153.993663 153.999261 negative MGI_C57BL6J_5590725 Gm31566 NCBI_Gene:102633836 MGI:5590725 lncRNA gene predicted gene, 31566
4 gene 154.011731 154.021513 positive MGI_C57BL6J_1920196 Lrrc47 NCBI_Gene:72946,ENSEMBL:ENSMUSG00000029028 MGI:1920196 protein coding gene leucine rich repeat containing 47
4 gene 154.020470 154.026230 negative MGI_C57BL6J_1916109 Smim1 NCBI_Gene:68859,ENSEMBL:ENSMUSG00000078350 MGI:1916109 protein coding gene small integral membrane protein 1
chr type start stop strand ID Name Dbxref gene_id mgi_type description
19 gene 3.259076 3.283017 negative MGI_C57BL6J_99954 Ighmbp2 NCBI_Gene:20589,ENSEMBL:ENSMUSG00000024831 MGI:99954 protein coding gene immunoglobulin mu binding protein 2
19 gene 3.282901 3.292837 positive MGI_C57BL6J_2660674 Mrpl21 NCBI_Gene:353242,ENSEMBL:ENSMUSG00000024829 MGI:2660674 protein coding gene mitochondrial ribosomal protein L21
19 gene 3.288920 3.288983 positive MGI_C57BL6J_5531153 Mir6984 miRBase:MI0022832,NCBI_Gene:102465594,ENSEMBL:ENSMUSG00000099261 MGI:5531153 miRNA gene microRNA 6984
19 pseudogene 3.316782 3.317581 negative MGI_C57BL6J_6303159 Gm50307 ENSEMBL:ENSMUSG00000118213 MGI:6303159 pseudogene predicted gene, 50307
19 gene 3.322325 3.385735 positive MGI_C57BL6J_1098296 Cpt1a NCBI_Gene:12894,ENSEMBL:ENSMUSG00000024900 MGI:1098296 protein coding gene carnitine palmitoyltransferase 1a, liver
19 gene 3.373448 3.378102 negative MGI_C57BL6J_5595691 Gm36532 NCBI_Gene:102640483 MGI:5595691 lncRNA gene predicted gene, 36532
19 gene 3.386211 3.387996 positive MGI_C57BL6J_1921854 4833417J20Rik NA NA unclassified gene RIKEN cDNA 4833417J20 gene
19 gene 3.388857 3.407823 positive MGI_C57BL6J_1340029 Tesmin NCBI_Gene:17771,ENSEMBL:ENSMUSG00000024905 MGI:1340029 protein coding gene testis expressed metallothionein like
19 gene 3.409915 3.414544 negative MGI_C57BL6J_95637 Gal NCBI_Gene:14419,ENSEMBL:ENSMUSG00000024907 MGI:95637 protein coding gene galanin and GMAP prepropeptide
19 gene 3.454928 3.575749 negative MGI_C57BL6J_1921807 Ppp6r3 NCBI_Gene:52036,ENSEMBL:ENSMUSG00000024908 MGI:1921807 protein coding gene protein phosphatase 6, regulatory subunit 3
19 gene 3.486090 3.488014 positive MGI_C57BL6J_6098329 Gm48696 ENSEMBL:ENSMUSG00000114315 MGI:6098329 lncRNA gene predicted gene, 48696
19 gene 3.490309 3.490413 positive MGI_C57BL6J_5453717 Gm23940 ENSEMBL:ENSMUSG00000075908 MGI:5453717 snRNA gene predicted gene, 23940
19 gene 3.527104 3.528613 positive MGI_C57BL6J_6098308 Gm48683 ENSEMBL:ENSMUSG00000114302 MGI:6098308 lncRNA gene predicted gene, 48683
19 pseudogene 3.567551 3.568448 positive MGI_C57BL6J_5011390 Gm19205 NCBI_Gene:100418426 MGI:5011390 pseudogene predicted gene, 19205
19 gene 3.576263 3.576335 positive MGI_C57BL6J_4413682 n-TAagc9 NCBI_Gene:102467450 MGI:4413682 tRNA gene nuclear encoded tRNA alanine 9 (anticodon AGC)
19 gene 3.584825 3.686564 negative MGI_C57BL6J_1278315 Lrp5 NCBI_Gene:16973,ENSEMBL:ENSMUSG00000024913 MGI:1278315 protein coding gene low density lipoprotein receptor-related protein 5
19 gene 3.686410 3.692435 positive MGI_C57BL6J_5595831 Gm36672 NCBI_Gene:102640658 MGI:5595831 protein coding gene predicted gene, 36672
19 gene 3.689236 3.708226 negative MGI_C57BL6J_5595767 Gm36608 NCBI_Gene:102640578,ENSEMBL:ENSMUSG00000118249 MGI:5595767 lncRNA gene predicted gene, 36608
19 gene 3.708293 3.717882 positive MGI_C57BL6J_1919306 1810055G02Rik NCBI_Gene:72056,ENSEMBL:ENSMUSG00000035372 MGI:1919306 protein coding gene RIKEN cDNA 1810055G02 gene
19 gene 3.712777 3.744426 negative MGI_C57BL6J_5595946 Gm36787 NCBI_Gene:102640806,ENSEMBL:ENSMUSG00000117739 MGI:5595946 lncRNA gene predicted gene, 36787
19 gene 3.719885 3.721369 positive MGI_C57BL6J_5596030 Gm36871 NCBI_Gene:102640924 MGI:5596030 lncRNA gene predicted gene, 36871
19 pseudogene 3.730432 3.731047 negative MGI_C57BL6J_3780310 Gm2141 NCBI_Gene:100039289,ENSEMBL:ENSMUSG00000118231 MGI:3780310 pseudogene predicted gene 2141
19 pseudogene 3.732094 3.732340 negative MGI_C57BL6J_6303269 Gm50374 ENSEMBL:ENSMUSG00000118096 MGI:6303269 pseudogene predicted gene, 50374
19 gene 3.740225 3.742537 negative MGI_C57BL6J_6303270 Gm50375 ENSEMBL:ENSMUSG00000117773 MGI:6303270 lncRNA gene predicted gene, 50375
19 gene 3.765976 3.818303 positive MGI_C57BL6J_2444557 Kmt5b NCBI_Gene:225888,ENSEMBL:ENSMUSG00000045098 MGI:2444557 protein coding gene lysine methyltransferase 5B
19 gene 3.798615 3.852419 negative MGI_C57BL6J_3801953 Gm16066 ENSEMBL:ENSMUSG00000082848 MGI:3801953 lncRNA gene predicted gene 16066
19 pseudogene 3.821562 3.822389 negative MGI_C57BL6J_5011394 Gm19209 NCBI_Gene:100418430,ENSEMBL:ENSMUSG00000117779 MGI:5011394 pseudogene predicted gene, 19209
19 gene 3.851585 3.894369 positive MGI_C57BL6J_107760 Chka NCBI_Gene:12660,ENSEMBL:ENSMUSG00000024843 MGI:107760 protein coding gene choline kinase alpha
19 gene 3.863568 3.867673 negative MGI_C57BL6J_6303282 Gm50383 ENSEMBL:ENSMUSG00000117912 MGI:6303282 lncRNA gene predicted gene, 50383
19 gene 3.896050 3.907133 negative MGI_C57BL6J_1350931 Tcirg1 NCBI_Gene:27060,ENSEMBL:ENSMUSG00000001750 MGI:1350931 protein coding gene T cell, immune regulator 1, ATPase, H+ transporting, lysosomal V0 protein A3
19 gene 3.908863 3.912774 negative MGI_C57BL6J_2385079 Ndufs8 NCBI_Gene:225887,ENSEMBL:ENSMUSG00000059734 MGI:2385079 protein coding gene NADH:ubiquinone oxidoreductase core subunit S8
19 gene 3.913491 3.930860 negative MGI_C57BL6J_1914939 Aldh3b1 NCBI_Gene:67689,ENSEMBL:ENSMUSG00000024885 MGI:1914939 protein coding gene aldehyde dehydrogenase 3 family, member B1
19 gene 3.919391 3.920826 positive MGI_C57BL6J_5624944 Gm42059 NCBI_Gene:105246837 MGI:5624944 lncRNA gene predicted gene, 42059
19 gene 3.923864 3.924975 positive MGI_C57BL6J_5589005 Gm29846 NCBI_Gene:102631533 MGI:5589005 lncRNA gene predicted gene, 29846
19 pseudogene 3.931795 3.932090 negative MGI_C57BL6J_6303191 Gm50327 ENSEMBL:ENSMUSG00000118129 MGI:6303191 pseudogene predicted gene, 50327
19 gene 3.935186 3.949340 positive MGI_C57BL6J_1859307 Unc93b1 NCBI_Gene:54445,ENSEMBL:ENSMUSG00000036908 MGI:1859307 protein coding gene unc-93 homolog B1, TLR signaling regulator
19 gene 3.958645 3.972419 positive MGI_C57BL6J_1920708 Aldh3b3 NCBI_Gene:73458,ENSEMBL:ENSMUSG00000037263 MGI:1920708 protein coding gene aldehyde dehydrogenase 3 family, member B3
19 gene 3.972328 3.981665 positive MGI_C57BL6J_2147613 Aldh3b2 NCBI_Gene:621603,ENSEMBL:ENSMUSG00000075296 MGI:2147613 protein coding gene aldehyde dehydrogenase 3 family, member B2
19 gene 3.986570 3.990007 positive MGI_C57BL6J_1918920 Acy3 NCBI_Gene:71670,ENSEMBL:ENSMUSG00000024866 MGI:1918920 protein coding gene aspartoacylase (aminoacylase) 3
19 gene 3.992752 3.999828 positive MGI_C57BL6J_1261436 Tbx10 NCBI_Gene:109575,ENSEMBL:ENSMUSG00000037477 MGI:1261436 protein coding gene T-box 10
19 gene 3.999548 4.000542 negative MGI_C57BL6J_1921038 4833408A19Rik ENSEMBL:ENSMUSG00000118132 MGI:1921038 lncRNA gene RIKEN cDNA 4833408A19 gene
19 gene 4.000580 4.002103 positive MGI_C57BL6J_1913637 Nudt8 NCBI_Gene:66387,ENSEMBL:ENSMUSG00000110949 MGI:1913637 protein coding gene nudix (nucleoside diphosphate linked moiety X)-type motif 8
19 gene 4.000626 4.005816 positive MGI_C57BL6J_6155029 Gm49405 ENSEMBL:ENSMUSG00000024869 MGI:6155029 protein coding gene predicted gene, 49405
19 gene 4.000758 4.001232 negative MGI_C57BL6J_3826559 Gm16312 ENSEMBL:ENSMUSG00000086107 MGI:3826559 lncRNA gene predicted gene 16312
19 gene 4.003313 4.007005 positive MGI_C57BL6J_1926250 Doc2g NCBI_Gene:60425,ENSEMBL:ENSMUSG00000024871 MGI:1926250 protein coding gene double C2, gamma
19 gene 4.007384 4.012806 negative MGI_C57BL6J_107851 Ndufv1 NCBI_Gene:17995,ENSEMBL:ENSMUSG00000037916 MGI:107851 protein coding gene NADH:ubiquinone oxidoreductase core subunit V1
19 gene 4.035407 4.037985 negative MGI_C57BL6J_95865 Gstp1 NCBI_Gene:14870,ENSEMBL:ENSMUSG00000060803 MGI:95865 protein coding gene glutathione S-transferase, pi 1
19 gene 4.040285 4.046023 negative MGI_C57BL6J_95864 Gstp2 NCBI_Gene:14869,ENSEMBL:ENSMUSG00000038155 MGI:95864 protein coding gene glutathione S-transferase, pi 2
19 gene 4.057470 4.059588 negative MGI_C57BL6J_2385078 Gstp3 NCBI_Gene:225884,ENSEMBL:ENSMUSG00000058216 MGI:2385078 protein coding gene glutathione S-transferase pi 3
19 gene 4.067251 4.071445 negative MGI_C57BL6J_5624945 Gm42060 NCBI_Gene:105246838 MGI:5624945 lncRNA gene predicted gene, 42060
19 gene 4.078297 4.078512 negative MGI_C57BL6J_5453704 Gm23927 ENSEMBL:ENSMUSG00000064400,ENSEMBL:ENSMUSG00000104921 MGI:5453704 snoRNA gene predicted gene, 23927
19 gene 4.081469 4.087340 positive MGI_C57BL6J_1352749 Cabp2 NCBI_Gene:29866,ENSEMBL:ENSMUSG00000024857 MGI:1352749 protein coding gene calcium binding protein 2
19 gene 4.096894 4.099019 positive MGI_C57BL6J_1098779 Cdk2ap2 NCBI_Gene:52004,ENSEMBL:ENSMUSG00000024856 MGI:1098779 protein coding gene CDK2-associated protein 2
19 gene 4.099998 4.113965 positive MGI_C57BL6J_1197524 Pitpnm1 NCBI_Gene:18739,ENSEMBL:ENSMUSG00000024851 MGI:1197524 protein coding gene phosphatidylinositol transfer protein, membrane-associated 1
19 gene 4.113756 4.127234 negative MGI_C57BL6J_109622 Aip NCBI_Gene:11632,ENSEMBL:ENSMUSG00000024847 MGI:109622 protein coding gene aryl-hydrocarbon receptor-interacting protein
19 gene 4.125934 4.132307 positive MGI_C57BL6J_1914240 Tmem134 NCBI_Gene:66990,ENSEMBL:ENSMUSG00000024845 MGI:1914240 protein coding gene transmembrane protein 134
19 gene 4.135423 4.144033 negative MGI_C57BL6J_1920910 Cabp4 NCBI_Gene:73660,ENSEMBL:ENSMUSG00000024842 MGI:1920910 protein coding gene calcium binding protein 4
19 gene 4.139787 4.145741 positive MGI_C57BL6J_2685519 Gpr152 NCBI_Gene:269053,ENSEMBL:ENSMUSG00000044724 MGI:2685519 protein coding gene G protein-coupled receptor 152
19 gene 4.148612 4.154035 positive MGI_C57BL6J_1345963 Coro1b NCBI_Gene:23789,ENSEMBL:ENSMUSG00000024835 MGI:1345963 protein coding gene coronin, actin binding protein 1B
19 gene 4.153604 4.156751 positive MGI_C57BL6J_97811 Ptprcap NCBI_Gene:19265,ENSEMBL:ENSMUSG00000045826 MGI:97811 protein coding gene protein tyrosine phosphatase, receptor type, C polypeptide-associated protein
19 gene 4.153991 4.163387 negative MGI_C57BL6J_1927343 Rps6kb2 NCBI_Gene:58988,ENSEMBL:ENSMUSG00000024830 MGI:1927343 protein coding gene ribosomal protein S6 kinase, polypeptide 2
19 gene 4.164324 4.175677 negative MGI_C57BL6J_2147595 Carns1 NCBI_Gene:107239,ENSEMBL:ENSMUSG00000075289 MGI:2147595 protein coding gene carnosine synthase 1
19 gene 4.168742 4.191047 negative MGI_C57BL6J_6303033 Gm50230 ENSEMBL:ENSMUSG00000117905 MGI:6303033 lncRNA gene predicted gene, 50230
19 gene 4.169566 4.174287 positive MGI_C57BL6J_4937186 Gm17552 NCBI_Gene:102631780,ENSEMBL:ENSMUSG00000097233 MGI:4937186 lncRNA gene predicted gene, 17552
19 gene 4.183411 4.191284 negative MGI_C57BL6J_1922072 Tbc1d10c NCBI_Gene:108995,ENSEMBL:ENSMUSG00000040247 MGI:1922072 protein coding gene TBC1 domain family, member 10c
19 gene 4.192065 4.195420 positive MGI_C57BL6J_103016 Ppp1ca NCBI_Gene:19045,ENSEMBL:ENSMUSG00000040385 MGI:103016 protein coding gene protein phosphatase 1 catalytic subunit alpha
19 gene 4.192109 4.192782 negative MGI_C57BL6J_6303067 Gm50251 ENSEMBL:ENSMUSG00000117839 MGI:6303067 lncRNA gene predicted gene, 50251
19 gene 4.195196 4.201662 negative MGI_C57BL6J_1328356 Rad9a NCBI_Gene:19367,ENSEMBL:ENSMUSG00000024824 MGI:1328356 protein coding gene RAD9 checkpoint clamp component A
19 gene 4.201706 4.203240 positive MGI_C57BL6J_5589241 Gm30082 NCBI_Gene:102631855,ENSEMBL:ENSMUSG00000118245 MGI:5589241 lncRNA gene predicted gene, 30082
19 gene 4.214238 4.223505 positive MGI_C57BL6J_1930088 Clcf1 NCBI_Gene:56708,ENSEMBL:ENSMUSG00000040663 MGI:1930088 protein coding gene cardiotrophin-like cytokine factor 1
19 gene 4.214238 4.233634 positive MGI_C57BL6J_5825565 Gm45928 NCBI_Gene:105948585,ENSEMBL:ENSMUSG00000117873 MGI:5825565 lncRNA gene predicted gene, 45928
19 gene 4.215402 4.215488 negative MGI_C57BL6J_5455892 Gm26115 ENSEMBL:ENSMUSG00000093346 MGI:5455892 miRNA gene predicted gene, 26115
19 gene 4.231893 4.233634 positive MGI_C57BL6J_1916995 Pold4 NCBI_Gene:69745,ENSEMBL:ENSMUSG00000024854 MGI:1916995 protein coding gene polymerase (DNA-directed), delta 4
19 gene 4.254031 4.257651 negative MGI_C57BL6J_1925555 1500032F14Rik ENSEMBL:ENSMUSG00000117718 MGI:1925555 lncRNA gene RIKEN cDNA 1500032F14 gene
19 gene 4.261668 4.269180 negative MGI_C57BL6J_2683546 Ssh3 NCBI_Gene:245857,ENSEMBL:ENSMUSG00000034616 MGI:2683546 protein coding gene slingshot protein phosphatase 3
19 gene 4.263818 4.263878 negative MGI_C57BL6J_5531101 Mir6985 miRBase:MI0022833,NCBI_Gene:102465595,ENSEMBL:ENSMUSG00000099290 MGI:5531101 miRNA gene microRNA 6985
19 gene 4.270180 4.283137 negative MGI_C57BL6J_1915673 Ankrd13d NCBI_Gene:68423,ENSEMBL:ENSMUSG00000005986 MGI:1915673 protein coding gene ankyrin repeat domain 13 family, member D
19 gene 4.273987 4.275643 positive MGI_C57BL6J_6302910 Gm50152 ENSEMBL:ENSMUSG00000118344 MGI:6302910 lncRNA gene predicted gene, 50152
19 gene 4.285999 4.306222 negative MGI_C57BL6J_87940 Grk2 NCBI_Gene:110355,ENSEMBL:ENSMUSG00000024858 MGI:87940 protein coding gene G protein-coupled receptor kinase 2
19 gene 4.314419 4.398596 negative MGI_C57BL6J_1354736 Kdm2a NCBI_Gene:225876,ENSEMBL:ENSMUSG00000054611 MGI:1354736 protein coding gene lysine (K)-specific demethylase 2A
19 gene 4.397714 4.399821 positive MGI_C57BL6J_3588259 9430078G10Rik NA NA unclassified gene RIKEN cDNA 9430078G10 gene
19 gene 4.425457 4.439432 negative MGI_C57BL6J_108446 Rhod NCBI_Gene:11854,ENSEMBL:ENSMUSG00000041845 MGI:108446 protein coding gene ras homolog family member D
19 gene 4.439003 4.448973 positive MGI_C57BL6J_2441838 A930001C03Rik NCBI_Gene:319314,ENSEMBL:ENSMUSG00000087132 MGI:2441838 lncRNA gene RIKEN cDNA A930001C03 gene
19 gene 4.445908 4.477447 negative MGI_C57BL6J_2159601 Syt12 NCBI_Gene:171180,ENSEMBL:ENSMUSG00000049303 MGI:2159601 protein coding gene synaptotagmin XII
19 gene 4.496788 4.498583 negative MGI_C57BL6J_1917111 2010003K11Rik NCBI_Gene:69861,ENSEMBL:ENSMUSG00000042041 MGI:1917111 protein coding gene RIKEN cDNA 2010003K11 gene
19 gene 4.510472 4.621752 positive MGI_C57BL6J_97520 Pcx NCBI_Gene:18563,ENSEMBL:ENSMUSG00000024892 MGI:97520 protein coding gene pyruvate carboxylase
19 gene 4.611784 4.615667 negative MGI_C57BL6J_2385612 Lrfn4 NCBI_Gene:225875,ENSEMBL:ENSMUSG00000045045 MGI:2385612 protein coding gene leucine rich repeat and fibronectin type III domain containing 4
19 gene 4.622551 4.625641 negative MGI_C57BL6J_1336895 Rce1 NCBI_Gene:19671,ENSEMBL:ENSMUSG00000024889 MGI:1336895 protein coding gene Ras converting CAAX endopeptidase 1
19 gene 4.623898 4.623955 negative MGI_C57BL6J_5531091 Mir6986 miRBase:MI0022834,NCBI_Gene:102466780,ENSEMBL:ENSMUSG00000098346 MGI:5531091 miRNA gene microRNA 6986
19 gene 4.625395 4.629857 positive MGI_C57BL6J_1921792 9030625N01Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 9030625N01 gene
19 gene 4.625734 4.698776 negative MGI_C57BL6J_2685806 Gm960 NCBI_Gene:381196,ENSEMBL:ENSMUSG00000071691 MGI:2685806 protein coding gene predicted gene 960
19 pseudogene 4.680115 4.680616 positive MGI_C57BL6J_6303266 Gm50372 ENSEMBL:ENSMUSG00000117746 MGI:6303266 pseudogene predicted gene, 50372
19 gene 4.711167 4.752360 positive MGI_C57BL6J_1313261 Sptbn2 NCBI_Gene:20743,ENSEMBL:ENSMUSG00000067889 MGI:1313261 protein coding gene spectrin beta, non-erythrocytic 2
19 gene 4.711651 4.720886 negative MGI_C57BL6J_5624946 Gm42061 NCBI_Gene:105246839 MGI:5624946 protein coding gene predicted gene, 42061
19 gene 4.742913 4.811634 negative MGI_C57BL6J_5439461 Gm21992 NCBI_Gene:102902673,ENSEMBL:ENSMUSG00000096370 MGI:5439461 protein coding gene predicted gene 21992
19 gene 4.752883 4.767065 positive MGI_C57BL6J_1913954 Rbm4b NCBI_Gene:66704,ENSEMBL:ENSMUSG00000033760 MGI:1913954 protein coding gene RNA binding motif protein 4B
19 gene 4.762103 4.765171 negative MGI_C57BL6J_5610434 Gm37206 ENSEMBL:ENSMUSG00000103651 MGI:5610434 unclassified gene predicted gene, 37206
19 pseudogene 4.778072 4.778697 positive MGI_C57BL6J_5011288 Gm19103 NCBI_Gene:100418257 MGI:5011288 pseudogene predicted gene, 19103
19 gene 4.784293 4.794009 negative MGI_C57BL6J_1100865 Rbm4 NCBI_Gene:19653,ENSEMBL:ENSMUSG00000094936 MGI:1100865 protein coding gene RNA binding motif protein 4
19 gene 4.794720 4.795956 negative MGI_C57BL6J_1918634 5430440L12Rik NA NA unclassified gene RIKEN cDNA 5430440L12 gene
19 gene 4.800566 4.811634 negative MGI_C57BL6J_1929092 Rbm14 NCBI_Gene:56275,ENSEMBL:ENSMUSG00000006456 MGI:1929092 protein coding gene RNA binding motif protein 14
19 gene 4.801512 4.805784 positive MGI_C57BL6J_5434008 Gm21844 ENSEMBL:ENSMUSG00000095913 MGI:5434008 lncRNA gene predicted gene, 21844
19 gene 4.825366 4.839332 negative MGI_C57BL6J_1333783 Ccs NCBI_Gene:12460,ENSEMBL:ENSMUSG00000034108 MGI:1333783 protein coding gene copper chaperone for superoxide dismutase
19 gene 4.839366 4.842528 positive MGI_C57BL6J_3026882 Ccdc87 NCBI_Gene:399599,ENSEMBL:ENSMUSG00000067872 MGI:3026882 protein coding gene coiled-coil domain containing 87
19 gene 4.855129 4.860918 positive MGI_C57BL6J_1861434 Ctsf NCBI_Gene:56464,ENSEMBL:ENSMUSG00000083282 MGI:1861434 protein coding gene cathepsin F
19 gene 4.861216 4.877909 negative MGI_C57BL6J_99678 Actn3 NCBI_Gene:11474,ENSEMBL:ENSMUSG00000006457 MGI:99678 protein coding gene actinin alpha 3
19 gene 4.878668 4.885397 positive MGI_C57BL6J_1917855 Zdhhc24 NCBI_Gene:70605,ENSEMBL:ENSMUSG00000006463 MGI:1917855 protein coding gene zinc finger, DHHC domain containing 24
19 gene 4.886878 4.906628 negative MGI_C57BL6J_1277215 Bbs1 NCBI_Gene:52028,ENSEMBL:ENSMUSG00000006464 MGI:1277215 protein coding gene Bardet-Biedl syndrome 1 (human)
19 gene 4.904673 4.904782 positive MGI_C57BL6J_5455111 Gm25334 ENSEMBL:ENSMUSG00000088661 MGI:5455111 snRNA gene predicted gene, 25334
19 gene 4.907229 4.928287 negative MGI_C57BL6J_1922471 Dpp3 NCBI_Gene:75221,ENSEMBL:ENSMUSG00000063904 MGI:1922471 protein coding gene dipeptidylpeptidase 3
19 gene 4.929717 4.943127 negative MGI_C57BL6J_1924963 Peli3 NCBI_Gene:240518,ENSEMBL:ENSMUSG00000024901 MGI:1924963 protein coding gene pellino 3
19 gene 4.962147 4.966999 positive MGI_C57BL6J_2137215 Mrpl11 NCBI_Gene:66419,ENSEMBL:ENSMUSG00000024902 MGI:2137215 protein coding gene mitochondrial ribosomal protein L11
19 gene 4.984353 5.001929 negative MGI_C57BL6J_2664186 Npas4 NCBI_Gene:225872,ENSEMBL:ENSMUSG00000045903 MGI:2664186 protein coding gene neuronal PAS domain protein 4
19 pseudogene 5.009385 5.009799 positive MGI_C57BL6J_6303281 Gm50382 ENSEMBL:ENSMUSG00000117723 MGI:6303281 pseudogene predicted gene, 50382
19 gene 5.017356 5.021765 negative MGI_C57BL6J_5624948 Gm42063 NCBI_Gene:105246841 MGI:5624948 lncRNA gene predicted gene, 42063
19 gene 5.023860 5.031972 positive MGI_C57BL6J_1345278 Slc29a2 NCBI_Gene:13340,ENSEMBL:ENSMUSG00000024891 MGI:1345278 protein coding gene solute carrier family 29 (nucleoside transporters), member 2
19 gene 5.037817 5.038805 negative MGI_C57BL6J_5589740 Gm30581 NCBI_Gene:102632530 MGI:5589740 lncRNA gene predicted gene, 30581
19 gene 5.038304 5.038385 negative MGI_C57BL6J_4414040 n-TSgct6 NCBI_Gene:102467380 MGI:4414040 tRNA gene nuclear encoded tRNA serine 6 (anticodon GCT)
19 gene 5.038826 5.041134 positive MGI_C57BL6J_1919680 B4gat1 NCBI_Gene:108902,ENSEMBL:ENSMUSG00000047379 MGI:1919680 protein coding gene beta-1,4-glucuronyltransferase 1
19 gene 5.038891 5.049912 positive MGI_C57BL6J_6303291 Gm50388 ENSEMBL:ENSMUSG00000117789 MGI:6303291 protein coding gene predicted gene, 50388
19 gene 5.041232 5.049917 positive MGI_C57BL6J_2388804 Brms1 NCBI_Gene:107392,ENSEMBL:ENSMUSG00000080268 MGI:2388804 protein coding gene breast cancer metastasis-suppressor 1
19 gene 5.050019 5.057072 positive MGI_C57BL6J_2385695 Rin1 NCBI_Gene:225870,ENSEMBL:ENSMUSG00000024883 MGI:2385695 protein coding gene Ras and Rab interactor 1
19 gene 5.068078 5.070682 positive MGI_C57BL6J_1917695 Cd248 NCBI_Gene:70445,ENSEMBL:ENSMUSG00000056481 MGI:1917695 protein coding gene CD248 antigen, endosialin
19 gene 5.070830 5.072120 negative MGI_C57BL6J_5589786 Gm30627 NCBI_Gene:102632593 MGI:5589786 lncRNA gene predicted gene, 30627
19 gene 5.070859 5.085531 negative MGI_C57BL6J_2147713 Tmem151a NCBI_Gene:381199,ENSEMBL:ENSMUSG00000061451 MGI:2147713 protein coding gene transmembrane protein 151A
19 gene 5.072130 5.075259 positive MGI_C57BL6J_5826295 Gm46658 NCBI_Gene:108168419,ENSEMBL:ENSMUSG00000117893 MGI:5826295 lncRNA gene predicted gene, 46658
19 gene 5.088538 5.092881 positive MGI_C57BL6J_1915340 Yif1a NCBI_Gene:68090,ENSEMBL:ENSMUSG00000024875 MGI:1915340 protein coding gene Yip1 interacting factor homolog A (S. cerevisiae)
19 gene 5.092868 5.098521 negative MGI_C57BL6J_1277225 Cnih2 NCBI_Gene:12794,ENSEMBL:ENSMUSG00000024873 MGI:1277225 protein coding gene cornichon family AMPA receptor auxiliary protein 2
19 gene 5.099205 5.107072 negative MGI_C57BL6J_1923558 Rab1b NCBI_Gene:76308,ENSEMBL:ENSMUSG00000024870 MGI:1923558 protein coding gene RAB1B, member RAS oncogene family
19 gene 5.107746 5.118573 negative MGI_C57BL6J_107953 Klc2 NCBI_Gene:16594,ENSEMBL:ENSMUSG00000024862 MGI:107953 protein coding gene kinesin light chain 2
19 gene 5.118038 5.119329 positive MGI_C57BL6J_3704489 Gm10817 ENSEMBL:ENSMUSG00000117710 MGI:3704489 lncRNA gene predicted gene 10817
19 gene 5.118844 5.126127 positive MGI_C57BL6J_5589999 Gm30840 NCBI_Gene:102632878 MGI:5589999 lncRNA gene predicted gene, 30840
19 pseudogene 5.131740 5.132972 negative MGI_C57BL6J_3779478 Gm5242 NCBI_Gene:383424,ENSEMBL:ENSMUSG00000117729 MGI:3779478 pseudogene predicted gene 5242
19 gene 5.133158 5.273119 negative MGI_C57BL6J_1277113 Pacs1 NCBI_Gene:107975,ENSEMBL:ENSMUSG00000024855 MGI:1277113 protein coding gene phosphofurin acidic cluster sorting protein 1
19 gene 5.201198 5.201303 negative MGI_C57BL6J_5530850 Gm27468 ENSEMBL:ENSMUSG00000098803 MGI:5530850 miRNA gene predicted gene, 27468
19 pseudogene 5.258750 5.258962 positive MGI_C57BL6J_6302964 Gm50189 ENSEMBL:ENSMUSG00000118104 MGI:6302964 pseudogene predicted gene, 50189
19 gene 5.273921 5.295457 negative MGI_C57BL6J_2441856 Sf3b2 NCBI_Gene:319322,ENSEMBL:ENSMUSG00000024853 MGI:2441856 protein coding gene splicing factor 3b, subunit 2
19 gene 5.295196 5.296028 positive MGI_C57BL6J_6302985 Gm50203 ENSEMBL:ENSMUSG00000118243 MGI:6302985 lncRNA gene predicted gene, 50203
19 gene 5.298331 5.308739 positive MGI_C57BL6J_3617843 Gal3st3 NCBI_Gene:545276,ENSEMBL:ENSMUSG00000047658 MGI:3617843 protein coding gene galactose-3-O-sulfotransferase 3
19 gene 5.305873 5.307416 negative MGI_C57BL6J_5624949 Gm42064 NCBI_Gene:105246843,ENSEMBL:ENSMUSG00000118263 MGI:5624949 lncRNA gene predicted gene, 42064
19 pseudogene 5.321606 5.321798 positive MGI_C57BL6J_6302994 Gm50208 ENSEMBL:ENSMUSG00000118009 MGI:6302994 pseudogene predicted gene, 50208
19 pseudogene 5.324014 5.325823 positive MGI_C57BL6J_3645420 Gm7074 NCBI_Gene:631868,ENSEMBL:ENSMUSG00000117807 MGI:3645420 pseudogene predicted gene 7074
19 gene 5.334032 5.335433 negative MGI_C57BL6J_5792253 Catsper1au NA NA antisense lncRNA gene Catsper1 antisense upstream transcript
19 gene 5.335602 5.344281 positive MGI_C57BL6J_2179947 Catsper1 NCBI_Gene:225865,ENSEMBL:ENSMUSG00000038498 MGI:2179947 protein coding gene cation channel, sperm associated 1
19 gene 5.344705 5.349574 negative MGI_C57BL6J_1920970 Cst6 NCBI_Gene:73720,ENSEMBL:ENSMUSG00000024846 MGI:1920970 protein coding gene cystatin E/M
19 gene 5.364633 5.367168 negative MGI_C57BL6J_1346330 Banf1 NCBI_Gene:23825,ENSEMBL:ENSMUSG00000024844 MGI:1346330 protein coding gene barrier to autointegration factor 1
19 gene 5.366741 5.371526 positive MGI_C57BL6J_1917110 Eif1ad NCBI_Gene:69860,ENSEMBL:ENSMUSG00000024841 MGI:1917110 protein coding gene eukaryotic translation initiation factor 1A domain containing
19 gene 5.377523 5.389304 negative MGI_C57BL6J_1309453 Sart1 NCBI_Gene:20227,ENSEMBL:ENSMUSG00000039148 MGI:1309453 protein coding gene squamous cell carcinoma antigen recognized by T cells 1
19 gene 5.388336 5.390069 positive MGI_C57BL6J_3041222 D330050I16Rik NCBI_Gene:414115,ENSEMBL:ENSMUSG00000117959 MGI:3041222 lncRNA gene RIKEN cDNA D330050I16 gene
19 gene 5.390047 5.402534 negative MGI_C57BL6J_1925556 Tsga10ip NCBI_Gene:78306,ENSEMBL:ENSMUSG00000039330 MGI:1925556 protein coding gene testis specific 10 interacting protein
19 gene 5.406740 5.422847 positive MGI_C57BL6J_1922181 4930481A15Rik NCBI_Gene:74931,ENSEMBL:ENSMUSG00000086938 MGI:1922181 lncRNA gene RIKEN cDNA 4930481A15 gene
19 pseudogene 5.415382 5.415811 negative MGI_C57BL6J_3649011 Gm6293 NCBI_Gene:102633050,ENSEMBL:ENSMUSG00000051133 MGI:3649011 pseudogene predicted pseudogene 6293
19 gene 5.422804 5.424979 negative MGI_C57BL6J_1913806 Drap1 NCBI_Gene:66556,ENSEMBL:ENSMUSG00000024914 MGI:1913806 protein coding gene Dr1 associated protein 1 (negative cofactor 2 alpha)
19 gene 5.425144 5.427317 positive MGI_C57BL6J_2147598 AI837181 NCBI_Gene:107242,ENSEMBL:ENSMUSG00000047423 MGI:2147598 protein coding gene expressed sequence AI837181
19 gene 5.435900 5.435965 positive MGI_C57BL6J_6302848 Gm50111 ENSEMBL:ENSMUSG00000088909 MGI:6302848 snoRNA gene predicted gene, 50111
19 pseudogene 5.435929 5.436800 positive MGI_C57BL6J_5455209 Gm25432 NCBI_Gene:102635008,ENSEMBL:ENSMUSG00000117771 MGI:5455209 pseudogene predicted gene, 25432
19 pseudogene 5.439246 5.439521 negative MGI_C57BL6J_5590229 Gm31070 NCBI_Gene:102633178,ENSEMBL:ENSMUSG00000117845 MGI:5590229 pseudogene predicted gene, 31070
19 gene 5.447547 5.455946 positive MGI_C57BL6J_107179 Fosl1 NCBI_Gene:14283,ENSEMBL:ENSMUSG00000024912 MGI:107179 protein coding gene fos-like antigen 1
19 gene 5.453163 5.457894 negative MGI_C57BL6J_2147607 Ccdc85b NCBI_Gene:240514,ENSEMBL:ENSMUSG00000095098 MGI:2147607 protein coding gene coiled-coil domain containing 85B
19 gene 5.460600 5.465052 positive MGI_C57BL6J_1926233 Fibp NCBI_Gene:58249,ENSEMBL:ENSMUSG00000024911 MGI:1926233 protein coding gene fibroblast growth factor (acidic) intracellular binding protein
19 gene 5.465043 5.470389 negative MGI_C57BL6J_1338045 Ctsw NCBI_Gene:13041,ENSEMBL:ENSMUSG00000024910 MGI:1338045 protein coding gene cathepsin W
19 gene 5.473954 5.482517 positive MGI_C57BL6J_1891209 Efemp2 NCBI_Gene:58859,ENSEMBL:ENSMUSG00000024909 MGI:1891209 protein coding gene epidermal growth factor-containing fibulin-like extracellular matrix protein 2
19 gene 5.482345 5.488410 negative MGI_C57BL6J_1918961 Mus81 NCBI_Gene:71711,ENSEMBL:ENSMUSG00000024906 MGI:1918961 protein coding gene MUS81 structure-specific endonuclease subunit
19 gene 5.488744 5.489198 negative MGI_C57BL6J_1920664 1700061A03Rik ENSEMBL:ENSMUSG00000117966 MGI:1920664 unclassified gene RIKEN cDNA 1700061A03 gene
19 gene 5.490455 5.495201 positive MGI_C57BL6J_101757 Cfl1 NCBI_Gene:12631,ENSEMBL:ENSMUSG00000056201 MGI:101757 protein coding gene cofilin 1, non-muscle
19 gene 5.492235 5.510696 negative MGI_C57BL6J_2444704 Snx32 NCBI_Gene:225861,ENSEMBL:ENSMUSG00000056185 MGI:2444704 protein coding gene sorting nexin 32
19 gene 5.502767 5.503787 negative MGI_C57BL6J_1922805 1700020D05Rik NCBI_Gene:75555,ENSEMBL:ENSMUSG00000100937 MGI:1922805 protein coding gene RIKEN cDNA 1700020D05 gene
19 pseudogene 5.510783 5.550374 positive MGI_C57BL6J_5590325 Gm31166 NCBI_Gene:102633307,ENSEMBL:ENSMUSG00000109695 MGI:5590325 pseudogene predicted gene, 31166
19 gene 5.549136 5.560646 negative MGI_C57BL6J_1330290 Ovol1 NCBI_Gene:18426,ENSEMBL:ENSMUSG00000024922 MGI:1330290 protein coding gene ovo like zinc finger 1
19 gene 5.560250 5.571262 positive MGI_C57BL6J_2685808 Ap5b1 NCBI_Gene:381201,ENSEMBL:ENSMUSG00000049562 MGI:2685808 protein coding gene adaptor-related protein complex 5, beta 1 subunit
19 gene 5.560260 5.561677 positive MGI_C57BL6J_1923763 1810058N15Rik ENSEMBL:ENSMUSG00000117861 MGI:1923763 lncRNA gene RIKEN cDNA 1810058N15 gene
19 gene 5.601873 5.607019 positive MGI_C57BL6J_1915459 Rnaseh2c NCBI_Gene:68209,ENSEMBL:ENSMUSG00000024925 MGI:1915459 protein coding gene ribonuclease H2, subunit C
19 gene 5.603014 5.610237 negative MGI_C57BL6J_1932051 Kat5 NCBI_Gene:81601,ENSEMBL:ENSMUSG00000024926 MGI:1932051 protein coding gene K(lysine) acetyltransferase 5
19 gene 5.637440 5.648131 positive MGI_C57BL6J_103290 Rela NCBI_Gene:19697,ENSEMBL:ENSMUSG00000024927 MGI:103290 protein coding gene v-rel reticuloendotheliosis viral oncogene homolog A (avian)
19 gene 5.651185 5.663839 negative MGI_C57BL6J_107576 Sipa1 NCBI_Gene:20469,ENSEMBL:ENSMUSG00000056917 MGI:107576 protein coding gene signal-induced proliferation associated gene 1
19 gene 5.664635 5.688908 negative MGI_C57BL6J_1861733 Pcnx3 NCBI_Gene:104401,ENSEMBL:ENSMUSG00000054874 MGI:1861733 protein coding gene pecanex homolog 3
19 gene 5.679004 5.679076 negative MGI_C57BL6J_5531273 Mir6987 miRBase:MI0022835,NCBI_Gene:102465596,ENSEMBL:ENSMUSG00000098568 MGI:5531273 miRNA gene microRNA 6987
19 gene 5.688740 5.702865 positive MGI_C57BL6J_1346880 Map3k11 NCBI_Gene:26403,ENSEMBL:ENSMUSG00000004054 MGI:1346880 protein coding gene mitogen-activated protein kinase kinase kinase 11
19 gene 5.689236 5.690010 negative MGI_C57BL6J_6303171 Gm50315 ENSEMBL:ENSMUSG00000118077 MGI:6303171 lncRNA gene predicted gene, 50315
19 gene 5.704367 5.707406 positive MGI_C57BL6J_1341841 Kcnk7 NCBI_Gene:16530,ENSEMBL:ENSMUSG00000024936 MGI:1341841 protein coding gene potassium channel, subfamily K, member 7
19 gene 5.707369 5.726461 negative MGI_C57BL6J_3612340 Ehbp1l1 NCBI_Gene:114601,ENSEMBL:ENSMUSG00000024937 MGI:3612340 protein coding gene EH domain binding protein 1-like 1
19 gene 5.727206 5.731627 positive MGI_C57BL6J_4414958 Gm16538 ENSEMBL:ENSMUSG00000089766 MGI:4414958 lncRNA gene predicted gene 16538
19 gene 5.728087 5.729666 negative MGI_C57BL6J_106595 Fam89b NCBI_Gene:17826,ENSEMBL:ENSMUSG00000024939 MGI:106595 protein coding gene family with sequence similarity 89, member B
19 gene 5.728088 5.731713 negative MGI_C57BL6J_6303289 Gm50387 ENSEMBL:ENSMUSG00000118125 MGI:6303289 protein coding gene predicted gene, 50387
19 gene 5.730303 5.731732 negative MGI_C57BL6J_1913482 Znrd2 NCBI_Gene:56390,ENSEMBL:ENSMUSG00000079478 MGI:1913482 protein coding gene zinc ribbon domain containing 2
19 gene 5.738405 5.740762 negative MGI_C57BL6J_3642330 Gm10815 NA NA unclassified gene predicted gene 10815
19 gene 5.740904 5.758532 positive MGI_C57BL6J_1101355 Ltbp3 NCBI_Gene:16998,ENSEMBL:ENSMUSG00000024940 MGI:1101355 protein coding gene latent transforming growth factor beta binding protein 3
19 gene 5.758351 5.771419 negative MGI_C57BL6J_1931787 Scyl1 NCBI_Gene:78891,ENSEMBL:ENSMUSG00000024941 MGI:1931787 protein coding gene SCY1-like 1 (S. cerevisiae)
19 gene 5.795690 5.802672 negative MGI_C57BL6J_1919539 Malat1 NCBI_Gene:72289,ENSEMBL:ENSMUSG00000092341 MGI:1919539 lncRNA gene metastasis associated lung adenocarcinoma transcript 1 (non-coding RNA)
19 gene 5.799000 5.799085 negative MGI_C57BL6J_5531076 Gm27694 ENSEMBL:ENSMUSG00000098462 MGI:5531076 unclassified non-coding RNA gene predicted gene, 27694
19 gene 5.801941 5.802393 positive MGI_C57BL6J_5610604 Gm37376 ENSEMBL:ENSMUSG00000102349 MGI:5610604 unclassified gene predicted gene, 37376
19 gene 5.824652 5.824707 negative MGI_C57BL6J_5531084 Gm27702 ENSEMBL:ENSMUSG00000098865 MGI:5531084 unclassified non-coding RNA gene predicted gene, 27702
19 gene 5.824708 5.845480 negative MGI_C57BL6J_1914211 Neat1 NCBI_Gene:66961,ENSEMBL:ENSMUSG00000092274 MGI:1914211 lncRNA gene nuclear paraspeckle assembly transcript 1 (non-protein coding)
19 gene 5.844286 5.844437 negative MGI_C57BL6J_5530915 Gm27533 ENSEMBL:ENSMUSG00000098543 MGI:5530915 unclassified non-coding RNA gene predicted gene, 27533
19 gene 5.844638 5.844747 negative MGI_C57BL6J_5530887 Gm27505 ENSEMBL:ENSMUSG00000098974 MGI:5530887 unclassified non-coding RNA gene predicted gene, 27505
19 gene 5.844916 5.845037 negative MGI_C57BL6J_5531388 Gm28006 ENSEMBL:ENSMUSG00000098986 MGI:5531388 unclassified non-coding RNA gene predicted gene, 28006
19 gene 5.845623 5.851388 positive MGI_C57BL6J_3704490 Frmd8os NCBI_Gene:69595,ENSEMBL:ENSMUSG00000043488 MGI:3704490 antisense lncRNA gene FERM domain containing 8, opposite strand
19 gene 5.849702 5.875274 negative MGI_C57BL6J_1914707 Frmd8 NCBI_Gene:67457,ENSEMBL:ENSMUSG00000024816 MGI:1914707 protein coding gene FERM domain containing 8
19 gene 5.877799 5.885878 positive MGI_C57BL6J_2147731 Slc25a45 NCBI_Gene:107375,ENSEMBL:ENSMUSG00000024818 MGI:2147731 protein coding gene solute carrier family 25, member 45
19 gene 5.891138 5.895169 negative MGI_C57BL6J_2681860 Tigd3 NCBI_Gene:332359,ENSEMBL:ENSMUSG00000044390 MGI:2681860 protein coding gene tigger transposable element derived 3
19 gene 5.896516 5.913010 negative MGI_C57BL6J_109529 Dpf2 NCBI_Gene:19708,ENSEMBL:ENSMUSG00000024826 MGI:109529 protein coding gene D4, zinc and double PHD fingers family 2
19 gene 5.912822 5.914831 positive MGI_C57BL6J_5624952 Gm42067 NCBI_Gene:105246846,ENSEMBL:ENSMUSG00000110156 MGI:5624952 lncRNA gene predicted gene, 42067
19 gene 5.915636 5.924816 negative MGI_C57BL6J_1929744 Cdc42ep2 NCBI_Gene:104252,ENSEMBL:ENSMUSG00000045664 MGI:1929744 protein coding gene CDC42 effector protein (Rho GTPase binding) 2
19 gene 5.940542 5.964216 negative MGI_C57BL6J_99690 Pola2 NCBI_Gene:18969,ENSEMBL:ENSMUSG00000024833 MGI:99690 protein coding gene polymerase (DNA directed), alpha 2
19 gene 5.970234 5.986143 negative MGI_C57BL6J_2685809 Slc22a20 NCBI_Gene:381203,ENSEMBL:ENSMUSG00000037451 MGI:2685809 protein coding gene solute carrier family 22 (organic anion transporter), member 20
19 gene 5.970486 5.984846 positive MGI_C57BL6J_5590878 Gm31719 NCBI_Gene:102634035 MGI:5590878 lncRNA gene predicted gene, 31719
19 gene 5.988545 6.015897 negative MGI_C57BL6J_88263 Capn1 NCBI_Gene:12333,ENSEMBL:ENSMUSG00000024942 MGI:88263 protein coding gene calpain 1
19 gene 6.012620 6.018462 positive MGI_C57BL6J_3642580 Gm10814 NCBI_Gene:100502985,ENSEMBL:ENSMUSG00000097404 MGI:3642580 lncRNA gene predicted gene 10814
19 pseudogene 6.027533 6.028401 negative MGI_C57BL6J_5011690 Gm19505 NCBI_Gene:100503014,ENSEMBL:ENSMUSG00000118194 MGI:5011690 pseudogene predicted gene, 19505
19 pseudogene 6.044442 6.044897 negative MGI_C57BL6J_3644144 Gm8034 NCBI_Gene:666300,ENSEMBL:ENSMUSG00000094281 MGI:3644144 pseudogene predicted gene 8034
19 gene 6.045060 6.047019 negative MGI_C57BL6J_1925963 D530017H19Rik NA NA unclassified non-coding RNA gene RIKEN cDNA D530017H19 gene
19 gene 6.046576 6.053718 positive MGI_C57BL6J_1921376 Syvn1 NCBI_Gene:74126,ENSEMBL:ENSMUSG00000024807 MGI:1921376 protein coding gene synovial apoptosis inhibitor 1, synoviolin
19 gene 6.051334 6.051392 positive MGI_C57BL6J_5530975 Mir6988 miRBase:MI0022836,NCBI_Gene:102465597,ENSEMBL:ENSMUSG00000098928 MGI:5530975 miRNA gene microRNA 6988
19 gene 6.053622 6.057785 negative MGI_C57BL6J_108180 Mrpl49 NCBI_Gene:18120,ENSEMBL:ENSMUSG00000007338 MGI:108180 protein coding gene mitochondrial ribosomal protein L49
19 gene 6.057844 6.059524 positive MGI_C57BL6J_102547 Fau NCBI_Gene:14109,ENSEMBL:ENSMUSG00000038274 MGI:102547 protein coding gene Finkel-Biskis-Reilly murine sarcoma virus (FBR-MuSV) ubiquitously expressed (fox derived)
19 gene 6.061192 6.062472 positive MGI_C57BL6J_1352481 Znhit2 NCBI_Gene:29805,ENSEMBL:ENSMUSG00000075227 MGI:1352481 protein coding gene zinc finger, HIT domain containing 2
19 gene 6.062821 6.068373 negative MGI_C57BL6J_1920416 Tm7sf2 NCBI_Gene:73166,ENSEMBL:ENSMUSG00000024799 MGI:1920416 protein coding gene transmembrane 7 superfamily member 2
19 gene 6.067842 6.077231 negative MGI_C57BL6J_1915755 Vps51 NCBI_Gene:68505,ENSEMBL:ENSMUSG00000024797 MGI:1915755 protein coding gene VPS51 GARP complex subunit
19 gene 6.076945 6.082256 negative MGI_C57BL6J_5579080 Gm28374 ENSEMBL:ENSMUSG00000100621 MGI:5579080 protein coding gene predicted gene 28374
19 gene 6.077884 6.080788 positive MGI_C57BL6J_3690536 Tmem262 NCBI_Gene:433215,ENSEMBL:ENSMUSG00000047733 MGI:3690536 protein coding gene transmembrane protein 262
19 gene 6.080757 6.084956 negative MGI_C57BL6J_1891017 Zfpl1 NCBI_Gene:81909,ENSEMBL:ENSMUSG00000024792 MGI:1891017 protein coding gene zinc finger like protein 1
19 gene 6.084983 6.091777 positive MGI_C57BL6J_1915099 Cdca5 NCBI_Gene:67849,ENSEMBL:ENSMUSG00000024791 MGI:1915099 protein coding gene cell division cycle associated 5
19 gene 6.093724 6.098241 positive MGI_C57BL6J_2685396 Gm550 NCBI_Gene:225852,ENSEMBL:ENSMUSG00000117666 MGI:2685396 protein coding gene predicted gene 550
19 gene 6.105782 6.115792 positive MGI_C57BL6J_2685810 Naaladl1 NCBI_Gene:381204,ENSEMBL:ENSMUSG00000054999 MGI:2685810 protein coding gene N-acetylated alpha-linked acidic dipeptidase-like 1
19 gene 6.116000 6.118650 negative MGI_C57BL6J_1913656 Sac3d1 NCBI_Gene:66406,ENSEMBL:ENSMUSG00000024790 MGI:1913656 protein coding gene SAC3 domain containing 1
19 gene 6.119399 6.132563 negative MGI_C57BL6J_1916274 Snx15 NCBI_Gene:69024,ENSEMBL:ENSMUSG00000024787 MGI:1916274 protein coding gene sorting nexin 15
19 gene 6.134374 6.141548 negative MGI_C57BL6J_1928393 Arl2 NCBI_Gene:56327,ENSEMBL:ENSMUSG00000024944 MGI:1928393 protein coding gene ADP-ribosylation factor-like 2
19 gene 6.140983 6.172476 positive MGI_C57BL6J_1921731 Batf2 NCBI_Gene:74481,ENSEMBL:ENSMUSG00000039699 MGI:1921731 protein coding gene basic leucine zipper transcription factor, ATF-like 2
19 gene 6.144732 6.144851 positive MGI_C57BL6J_4421753 n-R5s19 ENSEMBL:ENSMUSG00000084742 MGI:4421753 rRNA gene nuclear encoded rRNA 5S 19
19 pseudogene 6.152666 6.153712 positive MGI_C57BL6J_3648472 Gm5510 NCBI_Gene:433216,ENSEMBL:ENSMUSG00000083458 MGI:3648472 pseudogene predicted pseudogene 5510
19 gene 6.184328 6.225885 positive MGI_C57BL6J_1923913 Majin NCBI_Gene:622554,ENSEMBL:ENSMUSG00000024786 MGI:1923913 protein coding gene membrane anchored junction protein
19 gene 6.226380 6.227768 positive MGI_C57BL6J_2156541 Gpha2 NCBI_Gene:170458,ENSEMBL:ENSMUSG00000024784 MGI:2156541 protein coding gene glycoprotein hormone alpha 2
19 gene 6.227765 6.235872 negative MGI_C57BL6J_2388480 Ppp2r5b NCBI_Gene:225849,ENSEMBL:ENSMUSG00000024777 MGI:2388480 protein coding gene protein phosphatase 2, regulatory subunit B’, beta
19 gene 6.241664 6.262335 positive MGI_C57BL6J_1916291 Atg2a NCBI_Gene:329015,ENSEMBL:ENSMUSG00000024773 MGI:1916291 protein coding gene autophagy related 2A
19 gene 6.264643 6.264728 positive MGI_C57BL6J_3618738 Mir194-2 miRBase:MI0000733,NCBI_Gene:723957,ENSEMBL:ENSMUSG00000065582 MGI:3618738 miRNA gene microRNA 194-2
19 gene 6.264844 6.264932 positive MGI_C57BL6J_2676856 Mir192 miRBase:MI0000551,NCBI_Gene:387187,ENSEMBL:ENSMUSG00000065523 MGI:2676856 miRNA gene microRNA 192
19 gene 6.268794 6.276607 negative MGI_C57BL6J_3705162 Gm14963 NCBI_Gene:105246847,ENSEMBL:ENSMUSG00000085196 MGI:3705162 lncRNA gene predicted gene 14963
19 gene 6.276725 6.300096 positive MGI_C57BL6J_1341878 Ehd1 NCBI_Gene:13660,ENSEMBL:ENSMUSG00000024772 MGI:1341878 protein coding gene EH-domain containing 1
19 gene 6.306456 6.325653 positive MGI_C57BL6J_2652845 Cdc42bpg NCBI_Gene:240505,ENSEMBL:ENSMUSG00000024769 MGI:2652845 protein coding gene CDC42 binding protein kinase gamma (DMPK-like)
19 pseudogene 6.331054 6.331453 negative MGI_C57BL6J_6302977 Gm50198 ENSEMBL:ENSMUSG00000117681 MGI:6302977 pseudogene predicted gene, 50198
19 gene 6.334979 6.340894 positive MGI_C57BL6J_1316736 Men1 NCBI_Gene:17283,ENSEMBL:ENSMUSG00000024947 MGI:1316736 protein coding gene multiple endocrine neoplasia 1
19 gene 6.341117 6.355619 positive MGI_C57BL6J_1346883 Map4k2 NCBI_Gene:26412,ENSEMBL:ENSMUSG00000024948 MGI:1346883 protein coding gene mitogen-activated protein kinase kinase kinase kinase 2
19 gene 6.346480 6.346544 positive MGI_C57BL6J_5531267 Mir6989 miRBase:MI0022837,NCBI_Gene:102465598,ENSEMBL:ENSMUSG00000099230 MGI:5531267 miRNA gene microRNA 6989
19 gene 6.355473 6.363759 negative MGI_C57BL6J_3705223 Gm14966 NCBI_Gene:102634533,ENSEMBL:ENSMUSG00000079467 MGI:3705223 lncRNA gene predicted gene 14966
19 gene 6.363279 6.378038 positive MGI_C57BL6J_1095403 Sf1 NCBI_Gene:22668,ENSEMBL:ENSMUSG00000024949 MGI:1095403 protein coding gene splicing factor 1
19 gene 6.384399 6.398464 positive MGI_C57BL6J_97830 Pygm NCBI_Gene:19309,ENSEMBL:ENSMUSG00000032648 MGI:97830 protein coding gene muscle glycogen phosphorylase
19 gene 6.399008 6.415216 positive MGI_C57BL6J_1333849 Rasgrp2 NCBI_Gene:19395,ENSEMBL:ENSMUSG00000032946 MGI:1333849 protein coding gene RAS, guanyl releasing protein 2
19 gene 6.409400 6.418659 negative MGI_C57BL6J_3705214 Gm14965 NCBI_Gene:105246848,ENSEMBL:ENSMUSG00000084876 MGI:3705214 lncRNA gene predicted gene 14965
19 gene 6.418731 6.544169 positive MGI_C57BL6J_1096362 Nrxn2 NCBI_Gene:18190,ENSEMBL:ENSMUSG00000033768 MGI:1096362 protein coding gene neurexin II
19 gene 6.457419 6.460107 negative MGI_C57BL6J_6302908 Gm50151 ENSEMBL:ENSMUSG00000117897 MGI:6302908 unclassified gene predicted gene, 50151
19 gene 6.530711 6.532011 negative MGI_C57BL6J_3641621 Gm14964 ENSEMBL:ENSMUSG00000052188 MGI:3641621 lncRNA gene predicted gene 14964
19 gene 6.535845 6.543070 negative MGI_C57BL6J_1195269 Slc22a12 NCBI_Gene:20521,ENSEMBL:ENSMUSG00000061742 MGI:1195269 protein coding gene solute carrier family 22 (organic anion/cation transporter), member 12
19 gene 6.563780 6.563905 positive MGI_C57BL6J_5456237 Gm26460 ENSEMBL:ENSMUSG00000092802 MGI:5456237 miRNA gene predicted gene, 26460
19 gene 6.567126 6.578552 positive MGI_C57BL6J_5591404 Gm32245 NCBI_Gene:102634732 MGI:5591404 lncRNA gene predicted gene, 32245
19 pseudogene 6.569080 6.575362 negative MGI_C57BL6J_6303367 Gm50435 ENSEMBL:ENSMUSG00000118062 MGI:6303367 pseudogene predicted gene, 50435
19 pseudogene 6.592099 6.593339 negative MGI_C57BL6J_3768540 Hmgb1-ps4 NCBI_Gene:629372,ENSEMBL:ENSMUSG00000084221 MGI:3768540 pseudogene high mobility group box 1, pseudogene 4
19 gene 6.617671 6.674548 negative MGI_C57BL6J_1924061 2410152P15Rik ENSEMBL:ENSMUSG00000084825 MGI:1924061 lncRNA gene RIKEN cDNA 2410152P15 gene
19 gene 6.645687 6.647172 positive MGI_C57BL6J_3705315 Gm14968 ENSEMBL:ENSMUSG00000085285 MGI:3705315 lncRNA gene predicted gene 14968
19 gene 6.829084 6.840989 negative MGI_C57BL6J_1930076 Rps6ka4 NCBI_Gene:56613,ENSEMBL:ENSMUSG00000024952 MGI:1930076 protein coding gene ribosomal protein S6 kinase, polypeptide 4
19 gene 6.829886 6.829944 negative MGI_C57BL6J_4950413 Mir5046 miRBase:MI0017931,NCBI_Gene:100628576,ENSEMBL:ENSMUSG00000104884 MGI:4950413 miRNA gene microRNA 5046
19 gene 6.844623 6.858333 negative MGI_C57BL6J_1925567 Ccdc88b NCBI_Gene:78317,ENSEMBL:ENSMUSG00000047810 MGI:1925567 protein coding gene coiled-coil domain containing 88B
19 gene 6.906697 6.910106 negative MGI_C57BL6J_1859821 Prdx5 NCBI_Gene:54683,ENSEMBL:ENSMUSG00000024953 MGI:1859821 protein coding gene peroxiredoxin 5
19 gene 6.909698 6.911049 positive MGI_C57BL6J_1914924 Trmt112 NCBI_Gene:67674,ENSEMBL:ENSMUSG00000038812 MGI:1914924 protein coding gene tRNA methyltransferase 11-2
19 gene 6.910977 6.922048 negative MGI_C57BL6J_1346831 Esrra NCBI_Gene:26379,ENSEMBL:ENSMUSG00000024955 MGI:1346831 protein coding gene estrogen related receptor, alpha
19 gene 6.914196 6.914286 negative MGI_C57BL6J_5531108 Mir6990 miRBase:MI0022838,NCBI_Gene:102466213,ENSEMBL:ENSMUSG00000098413 MGI:5531108 miRNA gene microRNA 6990
19 gene 6.922371 6.925380 negative MGI_C57BL6J_1914327 Catsperz NCBI_Gene:67077,ENSEMBL:ENSMUSG00000050623 MGI:1914327 protein coding gene cation channel sperm associated auxiliary subunit zeta
19 gene 6.923966 6.934772 negative MGI_C57BL6J_1298234 Kcnk4 NCBI_Gene:16528,ENSEMBL:ENSMUSG00000024957 MGI:1298234 protein coding gene potassium channel, subfamily K, member 4
19 gene 6.927166 6.929518 positive MGI_C57BL6J_5826283 Gm46646 NCBI_Gene:108168407 MGI:5826283 lncRNA gene predicted gene, 46646
19 gene 6.938057 6.942480 negative MGI_C57BL6J_2147529 Gpr137 NCBI_Gene:107173,ENSEMBL:ENSMUSG00000024958 MGI:2147529 protein coding gene G protein-coupled receptor 137
19 gene 6.941861 6.951905 positive MGI_C57BL6J_1096330 Bad NCBI_Gene:12015,ENSEMBL:ENSMUSG00000024959 MGI:1096330 protein coding gene BCL2-associated agonist of cell death
19 pseudogene 6.945071 6.945620 negative MGI_C57BL6J_5011238 Gm19053 NCBI_Gene:100418171 MGI:5011238 pseudogene predicted gene, 19053
19 gene 6.952325 6.976470 negative MGI_C57BL6J_104778 Plcb3 NCBI_Gene:18797,ENSEMBL:ENSMUSG00000024960 MGI:104778 protein coding gene phospholipase C, beta 3
19 gene 6.974968 6.977324 positive MGI_C57BL6J_107682 Ppp1r14b NCBI_Gene:18938,ENSEMBL:ENSMUSG00000056612 MGI:107682 protein coding gene protein phosphatase 1, regulatory inhibitor subunit 14B
19 gene 6.977739 6.980501 negative MGI_C57BL6J_95542 Fkbp2 NCBI_Gene:14227,ENSEMBL:ENSMUSG00000056629 MGI:95542 protein coding gene FK506 binding protein 2
19 gene 6.980528 6.984168 positive MGI_C57BL6J_5624688 Gm41803 NCBI_Gene:105246528 MGI:5624688 lncRNA gene predicted gene, 41803
19 gene 6.982472 6.987651 negative MGI_C57BL6J_106199 Vegfb NCBI_Gene:22340,ENSEMBL:ENSMUSG00000024962 MGI:106199 protein coding gene vascular endothelial growth factor B
19 gene 6.987911 6.992697 negative MGI_C57BL6J_1927346 Dnajc4 NCBI_Gene:57431,ENSEMBL:ENSMUSG00000024963 MGI:1927346 protein coding gene DnaJ heat shock protein family (Hsp40) member C4
19 gene 6.992674 6.993046 positive MGI_C57BL6J_5594997 Gm35838 NCBI_Gene:102639551 MGI:5594997 lncRNA gene predicted gene, 35838
19 gene 6.993018 6.996117 negative MGI_C57BL6J_1915573 Nudt22 NCBI_Gene:68323,ENSEMBL:ENSMUSG00000037349 MGI:1915573 protein coding gene nudix (nucleoside diphosphate linked moiety X)-type motif 22
19 gene 6.996131 6.999048 positive MGI_C57BL6J_1333115 Trpt1 NCBI_Gene:107328,ENSEMBL:ENSMUSG00000047656 MGI:1333115 protein coding gene tRNA phosphotransferase 1
19 gene 6.998958 7.019469 negative MGI_C57BL6J_2147790 Fermt3 NCBI_Gene:108101,ENSEMBL:ENSMUSG00000024965 MGI:2147790 protein coding gene fermitin family member 3
19 gene 7.020696 7.040026 negative MGI_C57BL6J_109130 Stip1 NCBI_Gene:20867,ENSEMBL:ENSMUSG00000024966 MGI:109130 protein coding gene stress-induced phosphoprotein 1
19 gene 7.056713 7.198062 positive MGI_C57BL6J_2147583 Macrod1 NCBI_Gene:107227,ENSEMBL:ENSMUSG00000036278 MGI:2147583 protein coding gene MACRO domain containing 1
19 gene 7.084710 7.090741 positive MGI_C57BL6J_1917744 5730409K12Rik NCBI_Gene:70494 MGI:1917744 unclassified gene RIKEN cDNA 5730409K12 gene
19 gene 7.087464 7.166030 negative MGI_C57BL6J_3026647 Flrt1 NCBI_Gene:396184,ENSEMBL:ENSMUSG00000047787 MGI:3026647 protein coding gene fibronectin leucine rich transmembrane protein 1
19 gene 7.131506 7.136039 positive MGI_C57BL6J_5621506 Gm38621 NCBI_Gene:102642633 MGI:5621506 lncRNA gene predicted gene, 38621
19 gene 7.198202 7.206316 negative MGI_C57BL6J_2147616 Otub1 NCBI_Gene:107260,ENSEMBL:ENSMUSG00000024767 MGI:2147616 protein coding gene OTU domain, ubiquitin aldehyde binding 1
19 gene 7.215153 7.217616 negative MGI_C57BL6J_105959 Cox8a NCBI_Gene:12868,ENSEMBL:ENSMUSG00000035885 MGI:105959 protein coding gene cytochrome c oxidase subunit 8A
19 gene 7.225668 7.241222 negative MGI_C57BL6J_1918249 Naa40 NCBI_Gene:70999,ENSEMBL:ENSMUSG00000024764 MGI:1918249 protein coding gene N(alpha)-acetyltransferase 40, NatD catalytic subunit
19 gene 7.246709 7.246812 positive MGI_C57BL6J_5451890 Gm22113 ENSEMBL:ENSMUSG00000096774 MGI:5451890 snRNA gene predicted gene, 22113
19 gene 7.259941 7.260061 positive MGI_C57BL6J_5453774 Gm23997 ENSEMBL:ENSMUSG00000088680 MGI:5453774 rRNA gene predicted gene, 23997
19 gene 7.267325 7.275225 positive MGI_C57BL6J_1859854 Rcor2 NCBI_Gene:104383,ENSEMBL:ENSMUSG00000024968 MGI:1859854 protein coding gene REST corepressor 2
19 gene 7.275396 7.341867 negative MGI_C57BL6J_99638 Mark2 NCBI_Gene:13728,ENSEMBL:ENSMUSG00000024969 MGI:99638 protein coding gene MAP/microtubule affinity regulating kinase 2
19 gene 7.297654 7.304528 positive MGI_C57BL6J_4938054 Gm17227 NCBI_Gene:102639888,ENSEMBL:ENSMUSG00000091558 MGI:4938054 lncRNA gene predicted gene 17227
19 gene 7.324971 7.327376 negative MGI_C57BL6J_2441993 D830016O14Rik NA NA unclassified gene RIKEN cDNA D830016O14 gene
19 gene 7.354078 7.383051 negative MGI_C57BL6J_2147611 Spindoc NCBI_Gene:68229,ENSEMBL:ENSMUSG00000024970 MGI:2147611 protein coding gene spindlin interactor and repressor of chromatin binding
19 gene 7.364515 7.370240 positive MGI_C57BL6J_6303036 Gm50232 ENSEMBL:ENSMUSG00000117743 MGI:6303036 lncRNA gene predicted gene, 50232
19 gene 7.370339 7.372580 negative MGI_C57BL6J_5826284 Gm46647 NCBI_Gene:108168408 MGI:5826284 lncRNA gene predicted gene, 46647
19 gene 7.382537 7.383561 positive MGI_C57BL6J_1915479 1700105P06Rik NCBI_Gene:654802,ENSEMBL:ENSMUSG00000099923 MGI:1915479 lncRNA gene RIKEN cDNA 1700105P06 gene
19 pseudogene 7.397442 7.399173 negative MGI_C57BL6J_3643959 Rab11b-ps2 NCBI_Gene:665419,ENSEMBL:ENSMUSG00000095690 MGI:3643959 pseudogene RAB11B, member RAS oncogene family, pseudogene 2
19 pseudogene 7.402834 7.403431 negative MGI_C57BL6J_5011027 Gm18842 NCBI_Gene:100417810,ENSEMBL:ENSMUSG00000118297 MGI:5011027 pseudogene predicted gene, 18842
19 gene 7.417625 7.425904 positive MGI_C57BL6J_1919667 2700081O15Rik NCBI_Gene:108899,ENSEMBL:ENSMUSG00000053080 MGI:1919667 protein coding gene RIKEN cDNA 2700081O15 gene
19 gene 7.422573 7.422642 positive MGI_C57BL6J_5531348 Mir6991 miRBase:MI0022839,NCBI_Gene:102466781,ENSEMBL:ENSMUSG00000098293 MGI:5531348 miRNA gene microRNA 6991
19 gene 7.425895 7.483291 negative MGI_C57BL6J_1339970 Rtn3 NCBI_Gene:20168,ENSEMBL:ENSMUSG00000024758 MGI:1339970 protein coding gene reticulon 3
19 gene 7.465335 7.469619 negative MGI_C57BL6J_2444344 A830039H05Rik NA NA unclassified gene RIKEN cDNA A830039H05 gene
19 gene 7.472709 7.476413 negative MGI_C57BL6J_2443568 A830080L01Rik NA NA unclassified gene RIKEN cDNA A830080L01 gene
19 gene 7.494026 7.539674 positive MGI_C57BL6J_1924270 Atl3 NCBI_Gene:109168,ENSEMBL:ENSMUSG00000024759 MGI:1924270 protein coding gene atlastin GTPase 3
19 gene 7.557433 7.588545 positive MGI_C57BL6J_2179715 Plaat3 NCBI_Gene:225845,ENSEMBL:ENSMUSG00000060675 MGI:2179715 protein coding gene phospholipase A and acyltransferase 3
19 gene 7.596656 7.607237 negative MGI_C57BL6J_1929094 Lgals12 NCBI_Gene:56072,ENSEMBL:ENSMUSG00000024972 MGI:1929094 protein coding gene lectin, galactose binding, soluble 12
19 gene 7.612541 7.639642 positive MGI_C57BL6J_1913977 Plaat5 NCBI_Gene:66727,ENSEMBL:ENSMUSG00000024973 MGI:1913977 protein coding gene phospholipase A and acyltransferase 5
19 pseudogene 7.668271 7.669148 positive MGI_C57BL6J_3644508 Gm16437 NCBI_Gene:433217,ENSEMBL:ENSMUSG00000024761 MGI:3644508 pseudogene predicted pseudogene 16437
19 gene 7.673061 7.711310 negative MGI_C57BL6J_2442751 Slc22a19 NCBI_Gene:207151,ENSEMBL:ENSMUSG00000024757 MGI:2442751 protein coding gene solute carrier family 22 (organic anion transporter), member 19
19 pseudogene 7.695899 7.697016 negative MGI_C57BL6J_3801808 Gm15967 NCBI_Gene:100418172,ENSEMBL:ENSMUSG00000083160 MGI:3801808 pseudogene predicted gene 15967
19 pseudogene 7.703903 7.705127 negative MGI_C57BL6J_3801809 Gm15968 NCBI_Gene:100416946,ENSEMBL:ENSMUSG00000081596 MGI:3801809 pseudogene predicted gene 15968
19 pseudogene 7.727182 7.727673 negative MGI_C57BL6J_3647695 Gm8157 NCBI_Gene:666543,ENSEMBL:ENSMUSG00000117937 MGI:3647695 pseudogene predicted gene 8157
19 pseudogene 7.729370 7.729953 positive MGI_C57BL6J_5010729 Gm18544 NCBI_Gene:100417341 MGI:5010729 pseudogene predicted gene, 18544
19 gene 7.780468 7.802669 negative MGI_C57BL6J_2385316 Slc22a26 NCBI_Gene:236149,ENSEMBL:ENSMUSG00000053303 MGI:2385316 protein coding gene solute carrier family 22 (organic cation transporter), member 26
19 pseudogene 7.806297 7.848669 negative MGI_C57BL6J_3646592 Gm7096 NCBI_Gene:100534290,ENSEMBL:ENSMUSG00000118312 MGI:3646592 pseudogene predicted gene 7096
19 gene 7.864388 7.966595 negative MGI_C57BL6J_3042283 Slc22a27 NCBI_Gene:171405,ENSEMBL:ENSMUSG00000067656 MGI:3042283 protein coding gene solute carrier family 22, member 27
19 gene 7.959530 7.959638 negative MGI_C57BL6J_5454728 Gm24951 ENSEMBL:ENSMUSG00000076136 MGI:5454728 miRNA gene predicted gene, 24951
19 pseudogene 7.959743 7.961107 negative MGI_C57BL6J_3779569 Gm6192 NCBI_Gene:620946,ENSEMBL:ENSMUSG00000118220 MGI:3779569 pseudogene predicted gene 6192
19 pseudogene 7.975735 7.978339 positive MGI_C57BL6J_3643067 Gm6386 NCBI_Gene:623030,ENSEMBL:ENSMUSG00000118036 MGI:3643067 pseudogene predicted gene 6386
19 gene 8.019555 8.034088 positive MGI_C57BL6J_1925675 9530053H05Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 9530053H05 gene
19 gene 8.062209 8.131982 negative MGI_C57BL6J_3645714 Slc22a28 NCBI_Gene:434674,ENSEMBL:ENSMUSG00000063590 MGI:3645714 protein coding gene solute carrier family 22, member 28
19 gene 8.160165 8.253522 negative MGI_C57BL6J_3605624 Slc22a29 NCBI_Gene:236293,ENSEMBL:ENSMUSG00000075044 MGI:3605624 protein coding gene solute carrier family 22. member 29
19 gene 8.251312 8.317179 positive MGI_C57BL6J_5624689 Gm41804 NCBI_Gene:105246529,ENSEMBL:ENSMUSG00000118280 MGI:5624689 lncRNA gene predicted gene, 41804
19 pseudogene 8.255938 8.257662 negative MGI_C57BL6J_3644446 Gm7105 NCBI_Gene:633120,ENSEMBL:ENSMUSG00000118345 MGI:3644446 pseudogene predicted gene 7105
19 pseudogene 8.272397 8.275004 positive MGI_C57BL6J_3643112 Gm8184 NCBI_Gene:666601,ENSEMBL:ENSMUSG00000117877 MGI:3643112 pseudogene predicted gene 8184
19 gene 8.335371 8.405111 negative MGI_C57BL6J_2442750 Slc22a30 NCBI_Gene:319800,ENSEMBL:ENSMUSG00000052562 MGI:2442750 protein coding gene solute carrier family 22, member 30
19 pseudogene 8.473313 8.541800 negative MGI_C57BL6J_3779786 Gm8189 NCBI_Gene:100534389,ENSEMBL:ENSMUSG00000110298 MGI:3779786 pseudogene predicted gene 8189
19 pseudogene 8.588211 8.589292 negative MGI_C57BL6J_3646016 Gm6425 NCBI_Gene:623402,ENSEMBL:ENSMUSG00000086174 MGI:3646016 pseudogene predicted pseudogene 6425
19 gene 8.591254 8.611835 positive MGI_C57BL6J_1336187 Slc22a8 NCBI_Gene:19879,ENSEMBL:ENSMUSG00000063796 MGI:1336187 protein coding gene solute carrier family 22 (organic anion transporter), member 8
19 gene 8.611932 8.621184 negative MGI_C57BL6J_5595553 Gm36394 NCBI_Gene:102640287 MGI:5595553 lncRNA gene predicted gene, 36394
19 gene 8.617996 8.628299 positive MGI_C57BL6J_892001 Slc22a6 NCBI_Gene:18399,ENSEMBL:ENSMUSG00000024650 MGI:892001 protein coding gene solute carrier family 22 (organic anion transporter), member 6
19 gene 8.651796 8.663335 negative MGI_C57BL6J_3028064 9830166K06Rik NCBI_Gene:402757,ENSEMBL:ENSMUSG00000117763 MGI:3028064 lncRNA gene RIKEN cDNA 9830166K06 gene
19 gene 8.663789 8.683606 positive MGI_C57BL6J_88396 Chrm1 NCBI_Gene:12669,ENSEMBL:ENSMUSG00000032773 MGI:88396 protein coding gene cholinergic receptor, muscarinic 1, CNS
19 gene 8.681835 8.682163 negative MGI_C57BL6J_5452597 Gm22820 ENSEMBL:ENSMUSG00000087830 MGI:5452597 unclassified non-coding RNA gene predicted gene, 22820
19 gene 8.706882 8.723369 negative MGI_C57BL6J_96955 Slc3a2 NCBI_Gene:17254,ENSEMBL:ENSMUSG00000010095 MGI:96955 protein coding gene solute carrier family 3 (activators of dibasic and neutral amino acid transport), member 2
19 gene 8.723475 8.726443 positive MGI_C57BL6J_3763743 Snhg1 NCBI_Gene:83673,ENSEMBL:ENSMUSG00000108414 MGI:3763743 lncRNA gene small nucleolar RNA host gene 1
19 gene 8.723993 8.724064 positive MGI_C57BL6J_5455632 Gm25855 ENSEMBL:ENSMUSG00000064721 MGI:5455632 snoRNA gene predicted gene, 25855
19 gene 8.724251 8.724325 positive MGI_C57BL6J_5455671 Gm25894 ENSEMBL:ENSMUSG00000065392 MGI:5455671 snoRNA gene predicted gene, 25894
19 gene 8.724531 8.724602 positive MGI_C57BL6J_5454229 Gm24452 ENSEMBL:ENSMUSG00000065281 MGI:5454229 snoRNA gene predicted gene, 24452
19 gene 8.724868 8.724943 positive MGI_C57BL6J_5454230 Gm24453 ENSEMBL:ENSMUSG00000065280 MGI:5454230 snoRNA gene predicted gene, 24453
19 gene 8.725092 8.725156 positive MGI_C57BL6J_5452521 Gm22744 ENSEMBL:ENSMUSG00000065378 MGI:5452521 snoRNA gene predicted gene, 22744
19 gene 8.725341 8.725409 positive MGI_C57BL6J_5452457 Gm22680 ENSEMBL:ENSMUSG00000065782 MGI:5452457 snoRNA gene predicted gene, 22680
19 gene 8.725594 8.725660 positive MGI_C57BL6J_5453023 Gm23246 ENSEMBL:ENSMUSG00000065305 MGI:5453023 snoRNA gene predicted gene, 23246
19 gene 8.725866 8.725991 positive MGI_C57BL6J_1933385 Snord22 NCBI_Gene:100127111,ENSEMBL:ENSMUSG00000065087 MGI:1933385 snoRNA gene small nucleolar RNA, C/D box 22
19 gene 8.735804 8.740624 positive MGI_C57BL6J_2147427 Wdr74 NCBI_Gene:107071,ENSEMBL:ENSMUSG00000042729 MGI:2147427 protein coding gene WD repeat domain 74
19 gene 8.740718 8.741225 positive MGI_C57BL6J_1921557 1700092M07Rik NCBI_Gene:74307,ENSEMBL:ENSMUSG00000090840 MGI:1921557 protein coding gene RIKEN cDNA 1700092M07 gene
19 gene 8.741413 8.756069 positive MGI_C57BL6J_1928483 Stx5a NCBI_Gene:56389,ENSEMBL:ENSMUSG00000010110 MGI:1928483 protein coding gene syntaxin 5A
19 gene 8.742971 8.743079 positive MGI_C57BL6J_5531288 Mir6992 miRBase:MI0022840,NCBI_Gene:102465599,ENSEMBL:ENSMUSG00000098844 MGI:5531288 miRNA gene microRNA 6992
19 gene 8.754789 8.756969 negative MGI_C57BL6J_1916695 1700023D09Rik NCBI_Gene:102640359 MGI:1916695 lncRNA gene RIKEN cDNA 1700023D09 gene
19 gene 8.757073 8.770922 positive MGI_C57BL6J_1858330 Nxf1 NCBI_Gene:53319,ENSEMBL:ENSMUSG00000010097 MGI:1858330 protein coding gene nuclear RNA export factor 1
19 gene 8.770996 8.772475 positive MGI_C57BL6J_1914086 Tmem223 NCBI_Gene:66836,ENSEMBL:ENSMUSG00000117924 MGI:1914086 protein coding gene transmembrane protein 223
19 gene 8.772522 8.774467 negative MGI_C57BL6J_1914956 Tmem179b NCBI_Gene:67706,ENSEMBL:ENSMUSG00000118346 MGI:1914956 protein coding gene transmembrane protein 179B
19 gene 8.774354 8.786417 negative MGI_C57BL6J_2444957 Taf6l NCBI_Gene:225895,ENSEMBL:ENSMUSG00000003680 MGI:2444957 protein coding gene TATA-box binding protein associated factor 6 like
19 pseudogene 8.774485 8.776962 positive MGI_C57BL6J_3780685 Gm2518 NCBI_Gene:100039957,ENSEMBL:ENSMUSG00000118261 MGI:3780685 pseudogene predicted gene 2518
19 pseudogene 8.790085 8.790464 negative MGI_C57BL6J_6302874 Gm50131 ENSEMBL:ENSMUSG00000118305 MGI:6302874 pseudogene predicted gene, 50131
19 gene 8.793127 8.798577 negative MGI_C57BL6J_1914960 Polr2g NCBI_Gene:67710,ENSEMBL:ENSMUSG00000071662 MGI:1914960 protein coding gene polymerase (RNA) II (DNA directed) polypeptide G
19 gene 8.801979 8.804854 positive MGI_C57BL6J_1922541 Zbtb3 NCBI_Gene:75291,ENSEMBL:ENSMUSG00000071661 MGI:1922541 protein coding gene zinc finger and BTB domain containing 3
19 gene 8.809066 8.819455 negative MGI_C57BL6J_1917637 Ttc9c NCBI_Gene:70387,ENSEMBL:ENSMUSG00000071660 MGI:1917637 protein coding gene tetratricopeptide repeat domain 9C
19 gene 8.819401 8.834143 positive MGI_C57BL6J_1915943 Hnrnpul2 NCBI_Gene:68693,ENSEMBL:ENSMUSG00000071659 MGI:1915943 protein coding gene heterogeneous nuclear ribonucleoprotein U-like 2
19 gene 8.829773 8.841137 positive MGI_C57BL6J_6302888 Gm50139 ENSEMBL:ENSMUSG00000118124 MGI:6302888 protein coding gene predicted gene, 50139
19 gene 8.836929 8.839246 negative MGI_C57BL6J_102704 Gng3 NCBI_Gene:14704,ENSEMBL:ENSMUSG00000071658 MGI:102704 protein coding gene guanine nucleotide binding protein (G protein), gamma 3
19 gene 8.837467 8.848683 positive MGI_C57BL6J_1298392 Bscl2 NCBI_Gene:14705,ENSEMBL:ENSMUSG00000071657 MGI:1298392 protein coding gene Berardinelli-Seip congenital lipodystrophy 2 (seipin)
19 gene 8.850194 8.853914 positive MGI_C57BL6J_1916102 Lrrn4cl NCBI_Gene:68852,ENSEMBL:ENSMUSG00000071656 MGI:1916102 protein coding gene LRRN4 C-terminal like
19 gene 8.871496 8.875863 positive MGI_C57BL6J_1289301 Ubxn1 NCBI_Gene:225896,ENSEMBL:ENSMUSG00000071655 MGI:1289301 protein coding gene UBX domain protein 1
19 gene 8.880014 8.880933 negative MGI_C57BL6J_2147553 Uqcc3 NCBI_Gene:107197,ENSEMBL:ENSMUSG00000071654 MGI:2147553 protein coding gene ubiquinol-cytochrome c reductase complex assembly factor 3
19 gene 8.883732 8.892627 positive MGI_C57BL6J_5516029 Lbhd1 NCBI_Gene:102308570,ENSEMBL:ENSMUSG00000096740 MGI:5516029 protein coding gene LBH domain containing 1
19 gene 8.883930 8.887258 positive MGI_C57BL6J_6155026 Gm49403 ENSEMBL:ENSMUSG00000116166 MGI:6155026 protein coding gene predicted gene, 49403
19 gene 8.888387 8.888770 negative MGI_C57BL6J_1914781 5730408K05Rik NCBI_Gene:67531 MGI:1914781 lncRNA gene RIKEN cDNA 5730408K05 gene
19 gene 8.888538 8.888685 negative MGI_C57BL6J_5455599 Snora57 ENSEMBL:ENSMUSG00000070167 MGI:5455599 snoRNA gene small nucleolar RNA, H/ACA box 57
19 gene 8.888699 8.888774 negative MGI_C57BL6J_4950461 Mir5136 miRBase:MI0018048,NCBI_Gene:100628605,ENSEMBL:ENSMUSG00000093314 MGI:4950461 miRNA gene microRNA 5136
19 gene 8.888853 8.890881 positive MGI_C57BL6J_1913526 1810009A15Rik NCBI_Gene:66276,ENSEMBL:ENSMUSG00000071653 MGI:1913526 protein coding gene RIKEN cDNA 1810009A15 gene
19 gene 8.888926 8.895227 positive MGI_C57BL6J_6155046 Gm49416 ENSEMBL:ENSMUSG00000116347 MGI:6155046 protein coding gene predicted gene, 49416
19 gene 8.892987 8.897890 positive MGI_C57BL6J_1923578 Ints5 NCBI_Gene:109077,ENSEMBL:ENSMUSG00000071652 MGI:1923578 protein coding gene integrator complex subunit 5
19 gene 8.898057 8.916742 positive MGI_C57BL6J_1097667 Ganab NCBI_Gene:14376,ENSEMBL:ENSMUSG00000071650 MGI:1097667 protein coding gene alpha glucosidase 2 alpha neutral subunit
19 gene 8.918937 8.921842 negative MGI_C57BL6J_5595788 Gm36629 NCBI_Gene:102640604 MGI:5595788 lncRNA gene predicted gene, 36629
19 gene 8.920374 8.927236 positive MGI_C57BL6J_1919977 B3gat3 NCBI_Gene:72727,ENSEMBL:ENSMUSG00000071649 MGI:1919977 protein coding gene beta-1,3-glucuronyltransferase 3 (glucuronosyltransferase I)
19 gene 8.927382 8.929356 negative MGI_C57BL6J_97998 Rom1 NCBI_Gene:19881,ENSEMBL:ENSMUSG00000071648 MGI:97998 protein coding gene rod outer segment membrane protein 1
19 gene 8.929552 8.941582 positive MGI_C57BL6J_2387612 Eml3 NCBI_Gene:225898,ENSEMBL:ENSMUSG00000071647 MGI:2387612 protein coding gene echinoderm microtubule associated protein like 3
19 gene 8.936755 8.940896 negative MGI_C57BL6J_3704491 Gm10353 NCBI_Gene:102640526,ENSEMBL:ENSMUSG00000114220 MGI:3704491 lncRNA gene predicted gene 10353
19 gene 8.941875 8.952303 positive MGI_C57BL6J_1346340 Mta2 NCBI_Gene:23942,ENSEMBL:ENSMUSG00000071646 MGI:1346340 protein coding gene metastasis-associated gene family, member 2
19 gene 8.953847 8.966210 positive MGI_C57BL6J_1917294 Tut1 NCBI_Gene:70044,ENSEMBL:ENSMUSG00000071645 MGI:1917294 protein coding gene terminal uridylyl transferase 1, U6 snRNA-specific
19 gene 8.967041 8.978479 positive MGI_C57BL6J_1914410 Eef1g NCBI_Gene:67160,ENSEMBL:ENSMUSG00000071644 MGI:1914410 protein coding gene eukaryotic translation elongation factor 1 gamma
19 gene 8.989121 9.076935 positive MGI_C57BL6J_1316648 Ahnak NCBI_Gene:66395,ENSEMBL:ENSMUSG00000069833 MGI:1316648 protein coding gene AHNAK nucleoprotein (desmoyokin)
19 gene 9.083636 9.087958 negative MGI_C57BL6J_98919 Scgb1a1 NCBI_Gene:22287,ENSEMBL:ENSMUSG00000024653 MGI:98919 protein coding gene secretoglobin, family 1A, member 1 (uteroglobin)
19 gene 9.099766 9.102711 positive MGI_C57BL6J_5624690 Gm41805 NCBI_Gene:105246530 MGI:5624690 lncRNA gene predicted gene, 41805
19 gene 9.109868 9.135636 negative MGI_C57BL6J_1913764 Asrgl1 NCBI_Gene:66514,ENSEMBL:ENSMUSG00000024654 MGI:1913764 protein coding gene asparaginase like 1
19 gene 9.135157 9.279175 positive MGI_C57BL6J_3642669 Gm9750 NCBI_Gene:105246531,ENSEMBL:ENSMUSG00000024658 MGI:3642669 lncRNA gene predicted gene 9750
19 gene 9.185225 9.187019 negative MGI_C57BL6J_5621541 Gm38656 NCBI_Gene:102643088 MGI:5621541 protein coding gene predicted gene, 38656
19 pseudogene 9.216311 9.216995 positive MGI_C57BL6J_3644748 Gm6252 NCBI_Gene:621699,ENSEMBL:ENSMUSG00000117804 MGI:3644748 pseudogene predicted gene 6252
19 gene 9.234897 9.234978 negative MGI_C57BL6J_5454320 Gm24543 ENSEMBL:ENSMUSG00000077055 MGI:5454320 miRNA gene predicted gene, 24543
19 pseudogene 9.283238 9.284495 positive MGI_C57BL6J_97505 Pcna-ps2 NCBI_Gene:18540,ENSEMBL:ENSMUSG00000067608 MGI:97505 pseudogene proliferating cell nuclear antigen pseudogene 2
19 pseudogene 9.323219 9.339986 negative MGI_C57BL6J_3780785 Gm2617 ENSEMBL:ENSMUSG00000101398 MGI:3780785 pseudogene predicted gene 2617
19 pseudogene 9.557606 9.559248 negative MGI_C57BL6J_3586869 Stxbp3-ps NCBI_Gene:619371,ENSEMBL:ENSMUSG00000071640 MGI:3586869 pseudogene syntaxin-binding protein 3, pseudogene
19 pseudogene 9.605121 9.614034 positive MGI_C57BL6J_5579937 Gm29231 ENSEMBL:ENSMUSG00000096818 MGI:5579937 pseudogene predicted gene 29231
19 pseudogene 9.606968 9.608500 positive MGI_C57BL6J_3779598 Gm6445 NCBI_Gene:623688,ENSEMBL:ENSMUSG00000100141 MGI:3779598 pseudogene predicted gene 6445
19 pseudogene 9.827117 9.827236 positive MGI_C57BL6J_6303180 Gm50320 ENSEMBL:ENSMUSG00000117756 MGI:6303180 pseudogene predicted gene, 50320
19 gene 9.828899 9.836897 negative MGI_C57BL6J_6303181 Gm50321 ENSEMBL:ENSMUSG00000118383 MGI:6303181 lncRNA gene predicted gene, 50321
19 gene 9.847435 9.852808 positive MGI_C57BL6J_3780828 Scgb2a2 NCBI_Gene:102639117,ENSEMBL:ENSMUSG00000096872 MGI:3780828 protein coding gene secretoglobin, family 2A, member 2
19 gene 9.855319 9.855422 positive MGI_C57BL6J_5452146 Gm22369 ENSEMBL:ENSMUSG00000076370 MGI:5452146 miRNA gene predicted gene, 22369
19 gene 9.864924 9.868995 negative MGI_C57BL6J_6303183 Gm50322 ENSEMBL:ENSMUSG00000118138 MGI:6303183 lncRNA gene predicted gene, 50322
19 gene 9.872296 9.899551 negative MGI_C57BL6J_1313288 Incenp NCBI_Gene:16319,ENSEMBL:ENSMUSG00000024660 MGI:1313288 protein coding gene inner centromere protein
19 pseudogene 9.888477 9.889169 positive MGI_C57BL6J_5011239 Gm19054 NCBI_Gene:100418173 MGI:5011239 pseudogene predicted gene, 19054
19 gene 9.897500 9.898707 negative MGI_C57BL6J_6303187 Gm50324 ENSEMBL:ENSMUSG00000118325 MGI:6303187 unclassified gene predicted gene, 50324
19 gene 9.899690 9.902661 positive MGI_C57BL6J_6303216 Gm50340 ENSEMBL:ENSMUSG00000118100 MGI:6303216 lncRNA gene predicted gene, 50340
19 gene 9.908158 9.908278 positive MGI_C57BL6J_5454261 Gm24484 ENSEMBL:ENSMUSG00000080659 MGI:5454261 miRNA gene predicted gene, 24484
19 gene 9.924510 9.947628 negative MGI_C57BL6J_5596072 Gm36913 NCBI_Gene:102640980,ENSEMBL:ENSMUSG00000118008 MGI:5596072 lncRNA gene predicted gene, 36913
19 pseudogene 9.937669 9.937833 positive MGI_C57BL6J_6303221 Gm50343 ENSEMBL:ENSMUSG00000118065 MGI:6303221 pseudogene predicted gene, 50343
19 gene 9.939266 9.940652 positive MGI_C57BL6J_6303223 Gm50345 ENSEMBL:ENSMUSG00000118183 MGI:6303223 unclassified gene predicted gene, 50345
19 gene 9.941349 9.942832 negative MGI_C57BL6J_6303225 Gm50346 ENSEMBL:ENSMUSG00000118123 MGI:6303225 unclassified gene predicted gene, 50346
19 gene 9.970121 9.971605 positive MGI_C57BL6J_5624691 Gm41806 NCBI_Gene:105246532 MGI:5624691 lncRNA gene predicted gene, 41806
19 gene 9.980598 9.985111 positive MGI_C57BL6J_95588 Fth1 NCBI_Gene:14319,ENSEMBL:ENSMUSG00000024661 MGI:95588 protein coding gene ferritin heavy polypeptide 1
19 gene 9.985172 10.001633 negative MGI_C57BL6J_1346332 Best1 NCBI_Gene:24115,ENSEMBL:ENSMUSG00000037418 MGI:1346332 protein coding gene bestrophin 1
19 gene 10.001669 10.038380 positive MGI_C57BL6J_1922010 Rab3il1 NCBI_Gene:74760,ENSEMBL:ENSMUSG00000024663 MGI:1922010 protein coding gene RAB3A interacting protein (rabin3)-like 1
19 gene 10.040855 10.060110 positive MGI_C57BL6J_1928740 Fads3 NCBI_Gene:60527,ENSEMBL:ENSMUSG00000024664 MGI:1928740 protein coding gene fatty acid desaturase 3
19 gene 10.046264 10.047940 negative MGI_C57BL6J_5589076 Gm29917 NCBI_Gene:102631622 MGI:5589076 lncRNA gene predicted gene, 29917
19 gene 10.062765 10.101746 negative MGI_C57BL6J_1930079 Fads2 NCBI_Gene:56473,ENSEMBL:ENSMUSG00000024665 MGI:1930079 protein coding gene fatty acid desaturase 2
19 pseudogene 10.175854 10.176161 negative MGI_C57BL6J_6303246 Gm50359 ENSEMBL:ENSMUSG00000117700 MGI:6303246 pseudogene predicted gene, 50359
19 gene 10.182888 10.196877 positive MGI_C57BL6J_1923517 Fads1 NCBI_Gene:76267,ENSEMBL:ENSMUSG00000010663 MGI:1923517 protein coding gene fatty acid desaturase 1
19 gene 10.191375 10.191439 positive MGI_C57BL6J_5531024 Mir6993 miRBase:MI0022841,NCBI_Gene:102465600,ENSEMBL:ENSMUSG00000098363 MGI:5531024 miRNA gene microRNA 6993
19 gene 10.198368 10.202384 positive MGI_C57BL6J_3704492 Gm10143 ENSEMBL:ENSMUSG00000064032 MGI:3704492 lncRNA gene predicted gene 10143
19 gene 10.199132 10.204187 negative MGI_C57BL6J_102779 Fen1 NCBI_Gene:14156,ENSEMBL:ENSMUSG00000024742 MGI:102779 protein coding gene flap structure specific endonuclease 1
19 gene 10.204014 10.207824 positive MGI_C57BL6J_1916288 Tmem258 NCBI_Gene:69038,ENSEMBL:ENSMUSG00000036372 MGI:1916288 protein coding gene transmembrane protein 258
19 gene 10.208271 10.240781 negative MGI_C57BL6J_2684944 Myrf NCBI_Gene:225908,ENSEMBL:ENSMUSG00000036098 MGI:2684944 protein coding gene myelin regulatory factor
19 gene 10.245265 10.304877 negative MGI_C57BL6J_2677061 Dagla NCBI_Gene:269060,ENSEMBL:ENSMUSG00000035735 MGI:2677061 protein coding gene diacylglycerol lipase, alpha
19 gene 10.290223 10.296440 positive MGI_C57BL6J_5589201 Gm30042 NCBI_Gene:102631796,ENSEMBL:ENSMUSG00000118330 MGI:5589201 lncRNA gene predicted gene, 30042
19 gene 10.362065 10.366277 negative MGI_C57BL6J_5589422 Gm30263 NCBI_Gene:102632100 MGI:5589422 lncRNA gene predicted gene, 30263
19 gene 10.388781 10.453181 positive MGI_C57BL6J_1859545 Syt7 NCBI_Gene:54525,ENSEMBL:ENSMUSG00000024743 MGI:1859545 protein coding gene synaptotagmin VII
19 gene 10.389130 10.391735 negative MGI_C57BL6J_5477353 Gm26859 ENSEMBL:ENSMUSG00000097862 MGI:5477353 lncRNA gene predicted gene, 26859
19 gene 10.439897 10.442652 positive MGI_C57BL6J_6303093 Gm50268 ENSEMBL:ENSMUSG00000118310 MGI:6303093 unclassified gene predicted gene, 50268
19 gene 10.455371 10.457473 negative MGI_C57BL6J_2685551 Lrrc10b NCBI_Gene:278795,ENSEMBL:ENSMUSG00000090291 MGI:2685551 protein coding gene leucine rich repeat containing 10B
19 gene 10.474235 10.491452 negative MGI_C57BL6J_1915002 Ppp1r32 NCBI_Gene:67752,ENSEMBL:ENSMUSG00000035179 MGI:1915002 protein coding gene protein phosphatase 1, regulatory subunit 32
19 gene 10.500512 10.526142 negative MGI_C57BL6J_1913322 Sdhaf2 NCBI_Gene:66072,ENSEMBL:ENSMUSG00000024668 MGI:1913322 protein coding gene succinate dehydrogenase complex assembly factor 2
19 gene 10.525244 10.547735 positive MGI_C57BL6J_1917826 Cpsf7 NCBI_Gene:269061,ENSEMBL:ENSMUSG00000034820 MGI:1917826 protein coding gene cleavage and polyadenylation specific factor 7
19 gene 10.533865 10.556303 negative MGI_C57BL6J_1920020 Tmem216 NCBI_Gene:68642,ENSEMBL:ENSMUSG00000024667 MGI:1920020 protein coding gene transmembrane protein 216
19 gene 10.570478 10.577386 negative MGI_C57BL6J_1920232 Tmem138 NCBI_Gene:72982,ENSEMBL:ENSMUSG00000024666 MGI:1920232 protein coding gene transmembrane protein 138
19 gene 10.573512 10.576545 positive MGI_C57BL6J_6302988 Gm50205 ENSEMBL:ENSMUSG00000117955 MGI:6302988 unclassified gene predicted gene, 50205
19 gene 10.577157 10.595961 positive MGI_C57BL6J_2686925 Cyb561a3 NCBI_Gene:225912,ENSEMBL:ENSMUSG00000034445 MGI:2686925 protein coding gene cytochrome b561 family, member A3
19 gene 10.587791 10.605654 negative MGI_C57BL6J_2385084 Tkfc NCBI_Gene:225913,ENSEMBL:ENSMUSG00000034371 MGI:2385084 protein coding gene triokinase, FMN cyclase
19 gene 10.605327 10.629822 positive MGI_C57BL6J_1202384 Ddb1 NCBI_Gene:13194,ENSEMBL:ENSMUSG00000024740 MGI:1202384 protein coding gene damage specific DNA binding protein 1
19 gene 10.634213 10.666213 positive MGI_C57BL6J_1919018 Vwce NCBI_Gene:71768,ENSEMBL:ENSMUSG00000043789 MGI:1919018 protein coding gene von Willebrand factor C and EGF domains
19 gene 10.645690 10.648053 negative MGI_C57BL6J_1922346 4930524O05Rik NCBI_Gene:75096,ENSEMBL:ENSMUSG00000118392 MGI:1922346 lncRNA gene RIKEN cDNA 4930524O05 gene
19 gene 10.668956 10.678071 negative MGI_C57BL6J_1915935 Pga5 NCBI_Gene:58803,ENSEMBL:ENSMUSG00000024738 MGI:1915935 protein coding gene pepsinogen 5, group I
19 gene 10.684793 10.685558 positive MGI_C57BL6J_1919555 2210404E10Rik NCBI_Gene:72305,ENSEMBL:ENSMUSG00000114772 MGI:1919555 lncRNA gene RIKEN cDNA 2210404E10 gene
19 gene 10.688728 10.714628 positive MGI_C57BL6J_2147661 Vps37c NCBI_Gene:107305,ENSEMBL:ENSMUSG00000048832 MGI:2147661 protein coding gene vacuolar protein sorting 37C
19 gene 10.717116 10.739026 negative MGI_C57BL6J_88340 Cd5 NCBI_Gene:12507,ENSEMBL:ENSMUSG00000024669 MGI:88340 protein coding gene CD5 antigen
19 gene 10.740947 10.786043 positive MGI_C57BL6J_2685520 A430093F15Rik NCBI_Gene:403202,ENSEMBL:ENSMUSG00000067577 MGI:2685520 lncRNA gene RIKEN cDNA A430093F15 gene
19 gene 10.789339 10.830063 negative MGI_C57BL6J_103566 Cd6 NCBI_Gene:12511,ENSEMBL:ENSMUSG00000024670 MGI:103566 protein coding gene CD6 antigen
19 gene 10.839727 10.859362 positive MGI_C57BL6J_1929691 Slc15a3 NCBI_Gene:65221,ENSEMBL:ENSMUSG00000024737 MGI:1929691 protein coding gene solute carrier family 15, member 3
19 gene 10.840163 10.841762 negative MGI_C57BL6J_3641658 Gm10802 ENSEMBL:ENSMUSG00000118027 MGI:3641658 lncRNA gene predicted gene 10802
19 gene 10.857822 10.869940 negative MGI_C57BL6J_2147810 Tmem132a NCBI_Gene:98170,ENSEMBL:ENSMUSG00000024736 MGI:2147810 protein coding gene transmembrane protein 132A
19 gene 10.870657 10.882001 negative MGI_C57BL6J_1915789 Tmem109 NCBI_Gene:68539,ENSEMBL:ENSMUSG00000034659 MGI:1915789 protein coding gene transmembrane protein 109
19 gene 10.895231 10.909559 positive MGI_C57BL6J_106247 Prpf19 NCBI_Gene:28000,ENSEMBL:ENSMUSG00000024735 MGI:106247 protein coding gene pre-mRNA processing factor 19
19 gene 10.914287 10.920632 negative MGI_C57BL6J_103073 Zp1 NCBI_Gene:22786,ENSEMBL:ENSMUSG00000024734 MGI:103073 protein coding gene zona pellucida glycoprotein 1
19 gene 10.927861 10.942511 positive MGI_C57BL6J_1330275 Ptgdr2 NCBI_Gene:14764,ENSEMBL:ENSMUSG00000034117 MGI:1330275 protein coding gene prostaglandin D2 receptor 2
19 gene 10.941481 10.949266 negative MGI_C57BL6J_1277220 Ccdc86 NCBI_Gene:108673,ENSEMBL:ENSMUSG00000024732 MGI:1277220 protein coding gene coiled-coil domain containing 86
19 gene 10.962289 10.974725 negative MGI_C57BL6J_1917076 Ms4a10 NCBI_Gene:69826,ENSEMBL:ENSMUSG00000024731 MGI:1917076 protein coding gene membrane-spanning 4-domains, subfamily A, member 10
19 gene 10.978303 10.993518 negative MGI_C57BL6J_3617853 Ms4a15 NCBI_Gene:545279,ENSEMBL:ENSMUSG00000067571 MGI:3617853 protein coding gene membrane-spanning 4-domains, subfamily A, member 15
19 gene 10.997024 11.018031 negative MGI_C57BL6J_1923252 Ms4a18 NCBI_Gene:76002,ENSEMBL:ENSMUSG00000094584 MGI:1923252 protein coding gene membrane-spanning 4-domains, subfamily A, member 18
19 gene 11.035415 11.037635 negative MGI_C57BL6J_5579053 Gm28347 NCBI_Gene:102632179,ENSEMBL:ENSMUSG00000101264 MGI:5579053 lncRNA gene predicted gene 28347
19 gene 11.047612 11.055808 negative MGI_C57BL6J_2147706 AW112010 NCBI_Gene:107350,ENSEMBL:ENSMUSG00000075010 MGI:2147706 lncRNA gene expressed sequence AW112010
19 gene 11.067471 11.081103 negative MGI_C57BL6J_1927657 Ms4a8a NCBI_Gene:64381,ENSEMBL:ENSMUSG00000024730 MGI:1927657 protein coding gene membrane-spanning 4-domains, subfamily A, member 8A
19 pseudogene 11.090596 11.092077 negative MGI_C57BL6J_2685182 Gm336 NCBI_Gene:240539,ENSEMBL:ENSMUSG00000101439 MGI:2685182 pseudogene predicted pseudogene 336
19 gene 11.096814 11.130889 negative MGI_C57BL6J_1916619 1700017D01Rik NCBI_Gene:69369,ENSEMBL:ENSMUSG00000024729 MGI:1916619 protein coding gene RIKEN cDNA 1700017D01 gene
19 pseudogene 11.121344 11.122425 positive MGI_C57BL6J_3645570 Gm6501 NCBI_Gene:624395,ENSEMBL:ENSMUSG00000099998 MGI:3645570 pseudogene predicted gene 6501
19 gene 11.139662 11.165628 negative MGI_C57BL6J_1916666 1700025F22Rik NCBI_Gene:69416,ENSEMBL:ENSMUSG00000024728 MGI:1916666 protein coding gene RIKEN cDNA 1700025F22 gene
19 gene 11.169418 11.196934 negative MGI_C57BL6J_1920716 Ms4a13 NCBI_Gene:73466,ENSEMBL:ENSMUSG00000057240 MGI:1920716 protein coding gene membrane-spanning 4-domains, subfamily A, member 13
19 gene 11.196817 11.299886 positive MGI_C57BL6J_1922388 4930526L06Rik NCBI_Gene:75138,ENSEMBL:ENSMUSG00000097091 MGI:1922388 lncRNA gene RIKEN cDNA 4930526L06 gene
19 gene 11.214082 11.232482 negative MGI_C57BL6J_2685812 Ms4a12 NCBI_Gene:381213,ENSEMBL:ENSMUSG00000101031 MGI:2685812 protein coding gene membrane-spanning 4-domains, subfamily A, member 12
19 gene 11.249675 11.266241 negative MGI_C57BL6J_88321 Ms4a1 NCBI_Gene:12482,ENSEMBL:ENSMUSG00000024673 MGI:88321 protein coding gene membrane-spanning 4-domains, subfamily A, member 1
19 gene 11.273238 11.283895 negative MGI_C57BL6J_2670985 Ms4a5 NCBI_Gene:269063,ENSEMBL:ENSMUSG00000054523 MGI:2670985 protein coding gene membrane-spanning 4-domains, subfamily A, member 5
19 gene 11.301249 11.315875 negative MGI_C57BL6J_2686122 Ms4a14 NCBI_Gene:383435,ENSEMBL:ENSMUSG00000099398 MGI:2686122 protein coding gene membrane-spanning 4-domains, subfamily A, member 14
19 gene 11.321039 11.336146 negative MGI_C57BL6J_1918846 Ms4a7 NCBI_Gene:109225,ENSEMBL:ENSMUSG00000024672 MGI:1918846 protein coding gene membrane-spanning 4-domains, subfamily A, member 7
19 gene 11.362278 11.363890 positive MGI_C57BL6J_5579641 Gm28935 ENSEMBL:ENSMUSG00000100392 MGI:5579641 lncRNA gene predicted gene 28935
19 gene 11.375488 11.392915 positive MGI_C57BL6J_3643932 Ms4a4a NCBI_Gene:666907,ENSEMBL:ENSMUSG00000101389 MGI:3643932 protein coding gene membrane-spanning 4-domains, subfamily A, member 4A
19 pseudogene 11.403948 11.405004 negative MGI_C57BL6J_3646968 Gm5692 NCBI_Gene:435588,ENSEMBL:ENSMUSG00000101024 MGI:3646968 pseudogene predicted gene 5692
19 gene 11.404717 11.427246 positive MGI_C57BL6J_1927656 Ms4a4c NCBI_Gene:64380,ENSEMBL:ENSMUSG00000024675 MGI:1927656 protein coding gene membrane-spanning 4-domains, subfamily A, member 4C
19 pseudogene 11.438029 11.438832 positive MGI_C57BL6J_3779492 Gm5511 NCBI_Gene:433221,ENSEMBL:ENSMUSG00000100615 MGI:3779492 pseudogene predicted gene 5511
19 gene 11.443553 11.467055 positive MGI_C57BL6J_1913083 Ms4a4b NCBI_Gene:60361,ENSEMBL:ENSMUSG00000056290 MGI:1913083 protein coding gene membrane-spanning 4-domains, subfamily A, member 4B
19 gene 11.469041 11.487069 positive MGI_C57BL6J_2385644 Ms4a6c NCBI_Gene:73656,ENSEMBL:ENSMUSG00000079419 MGI:2385644 protein coding gene membrane-spanning 4-domains, subfamily A, member 6C
19 gene 11.470166 11.484578 negative MGI_C57BL6J_3035348 BE692007 NCBI_Gene:100504727,ENSEMBL:ENSMUSG00000099757 MGI:3035348 lncRNA gene expressed sequence BE692007
19 gene 11.485938 11.512577 positive MGI_C57BL6J_3645380 Gm8369 NCBI_Gene:666926,ENSEMBL:ENSMUSG00000058470 MGI:3645380 protein coding gene predicted gene 8369
19 gene 11.516211 11.516953 negative MGI_C57BL6J_5011446 Gm19261 ENSEMBL:ENSMUSG00000100529 MGI:5011446 lncRNA gene predicted gene, 19261
19 gene 11.516512 11.531256 positive MGI_C57BL6J_1917024 Ms4a6b NCBI_Gene:69774,ENSEMBL:ENSMUSG00000024677 MGI:1917024 protein coding gene membrane-spanning 4-domains, subfamily A, member 6B
19 gene 11.536801 11.558467 positive MGI_C57BL6J_1913857 Ms4a4d NCBI_Gene:66607,ENSEMBL:ENSMUSG00000024678 MGI:1913857 protein coding gene membrane-spanning 4-domains, subfamily A, member 4D
19 pseudogene 11.569439 11.573112 positive MGI_C57BL6J_3641904 Gm10212 NCBI_Gene:101055836,ENSEMBL:ENSMUSG00000067555 MGI:3641904 pseudogene predicted pseudogene 10212
19 gene 11.582826 11.584357 negative MGI_C57BL6J_5611503 Gm38275 ENSEMBL:ENSMUSG00000104088 MGI:5611503 unclassified gene predicted gene, 38275
19 gene 11.586604 11.604849 negative MGI_C57BL6J_1916024 Ms4a6d NCBI_Gene:68774,ENSEMBL:ENSMUSG00000024679 MGI:1916024 protein coding gene membrane-spanning 4-domains, subfamily A, member 6D
19 gene 11.607389 11.607438 negative MGI_C57BL6J_5454376 Gm24599 ENSEMBL:ENSMUSG00000088598 MGI:5454376 snoRNA gene predicted gene, 24599
19 gene 11.615517 11.623790 negative MGI_C57BL6J_95495 Ms4a2 NCBI_Gene:14126,ENSEMBL:ENSMUSG00000024680 MGI:95495 protein coding gene membrane-spanning 4-domains, subfamily A, member 2
19 gene 11.629496 11.640851 negative MGI_C57BL6J_2158468 Ms4a3 NCBI_Gene:170813,ENSEMBL:ENSMUSG00000024681 MGI:2158468 protein coding gene membrane-spanning 4-domains, subfamily A, member 3
19 gene 11.647279 11.660559 negative MGI_C57BL6J_2684945 Oosp2 NCBI_Gene:225922,ENSEMBL:ENSMUSG00000055895 MGI:2684945 protein coding gene oocyte secreted protein 2
19 gene 11.667460 11.691150 negative MGI_C57BL6J_2149290 Oosp1 NCBI_Gene:170834,ENSEMBL:ENSMUSG00000041857 MGI:2149290 protein coding gene oocyte secreted protein 1
19 gene 11.695041 11.695179 positive MGI_C57BL6J_5455960 Gm26183 ENSEMBL:ENSMUSG00000088310 MGI:5455960 snoRNA gene predicted gene, 26183
19 gene 11.695267 11.695342 positive MGI_C57BL6J_5455220 Gm25443 ENSEMBL:ENSMUSG00000089625 MGI:5455220 snoRNA gene predicted gene, 25443
19 gene 11.697055 11.711874 positive MGI_C57BL6J_2684943 Oosp3 NCBI_Gene:225923,ENSEMBL:ENSMUSG00000055933 MGI:2684943 protein coding gene oocyte secreted protein 3
19 pseudogene 11.703309 11.704101 negative MGI_C57BL6J_5011409 Gm19224 NCBI_Gene:100418458,ENSEMBL:ENSMUSG00000100918 MGI:5011409 pseudogene predicted gene, 19224
19 gene 11.747543 11.763447 positive MGI_C57BL6J_1202394 Cblif NCBI_Gene:14603,ENSEMBL:ENSMUSG00000024682 MGI:1202394 protein coding gene cobalamin binding intrinsic factor
19 gene 11.760943 11.763189 negative MGI_C57BL6J_5826292 Gm46655 NCBI_Gene:108168416 MGI:5826292 lncRNA gene predicted gene, 46655
19 gene 11.770391 11.774960 positive MGI_C57BL6J_2137219 Mrpl16 NCBI_Gene:94063,ENSEMBL:ENSMUSG00000024683 MGI:2137219 protein coding gene mitochondrial ribosomal protein L16
19 gene 11.775118 11.819886 negative MGI_C57BL6J_103077 Stx3 NCBI_Gene:20908,ENSEMBL:ENSMUSG00000041488 MGI:103077 protein coding gene syntaxin 3
19 gene 11.818245 11.831258 positive MGI_C57BL6J_5624695 Gm41810 NA NA lncRNA gene predicted gene%2c 41810
19 gene 11.826803 11.839219 negative MGI_C57BL6J_3031251 Olfr1417 NCBI_Gene:258938,ENSEMBL:ENSMUSG00000048292 MGI:3031251 protein coding gene olfactory receptor 1417
19 gene 11.852587 11.861066 negative MGI_C57BL6J_3031252 Olfr1418 NCBI_Gene:258227,ENSEMBL:ENSMUSG00000060556 MGI:3031252 protein coding gene olfactory receptor 1418
19 pseudogene 11.864436 11.864634 negative MGI_C57BL6J_5753695 Gm45119 ENSEMBL:ENSMUSG00000108966 MGI:5753695 pseudogene predicted gene 45119
19 gene 11.868613 11.875106 negative MGI_C57BL6J_3031253 Olfr1419 NCBI_Gene:257938,ENSEMBL:ENSMUSG00000067545 MGI:3031253 protein coding gene olfactory receptor 1419
19 pseudogene 11.876645 11.878668 negative MGI_C57BL6J_3643502 Gm6365 NCBI_Gene:622845,ENSEMBL:ENSMUSG00000051548 MGI:3643502 pseudogene predicted pseudogene 6365
19 gene 11.886565 11.898079 positive MGI_C57BL6J_3031254 Olfr1420 NCBI_Gene:258405,ENSEMBL:ENSMUSG00000060878 MGI:3031254 protein coding gene olfactory receptor 1420
19 gene 11.895522 11.912231 negative MGI_C57BL6J_5590251 Gm31092 NCBI_Gene:102633205 MGI:5590251 lncRNA gene predicted gene, 31092
19 gene 11.912399 11.945096 positive MGI_C57BL6J_2147679 Patl1 NCBI_Gene:225929,ENSEMBL:ENSMUSG00000046139 MGI:2147679 protein coding gene protein associated with topoisomerase II homolog 1 (yeast)
19 gene 11.923728 11.923800 positive MGI_C57BL6J_5562752 Mir6994 miRBase:MI0022842,NCBI_Gene:102465601,ENSEMBL:ENSMUSG00000104979 MGI:5562752 miRNA gene microRNA 6994
19 gene 11.933495 11.933628 negative MGI_C57BL6J_5452049 Gm22272 ENSEMBL:ENSMUSG00000077227 MGI:5452049 snoRNA gene predicted gene, 22272
19 pseudogene 11.958619 11.958994 positive MGI_C57BL6J_5826280 Gm46643 NCBI_Gene:108168403 MGI:5826280 pseudogene predicted gene, 46643
19 gene 11.965844 11.994114 positive MGI_C57BL6J_97447 Osbp NCBI_Gene:76303,ENSEMBL:ENSMUSG00000024687 MGI:97447 protein coding gene oxysterol binding protein
19 gene 12.002236 12.002308 positive MGI_C57BL6J_4414001 n-TFgaa6 NCBI_Gene:102467583 MGI:4414001 tRNA gene nuclear encoded tRNA pheylalanine 6 (anticodon GAA)
19 gene 12.006039 12.006111 positive MGI_C57BL6J_4413976 n-TKctt29 NCBI_Gene:102467572 MGI:4413976 tRNA gene nuclear encoded tRNA lysine 29 (anticodon TTT)
19 gene 12.008545 12.008617 positive MGI_C57BL6J_4413997 n-TFgaa2 NCBI_Gene:102467361 MGI:4413997 tRNA gene nuclear encoded tRNA pheylalanine 2 (anticodon GAA)
19 gene 12.009696 12.009768 negative MGI_C57BL6J_4413977 n-TKctt30 NCBI_Gene:102467353 MGI:4413977 tRNA gene nuclear encoded tRNA lysine 30 (anticodon TTT)
19 gene 12.010115 12.018404 positive MGI_C57BL6J_5590310 Gm31151 NCBI_Gene:102633290 MGI:5590310 lncRNA gene predicted gene, 31151
19 gene 12.011086 12.011168 negative MGI_C57BL6J_4413944 n-TLtaa4 NCBI_Gene:102467632 MGI:4413944 tRNA gene nuclear encoded tRNA leucine 4 (anticodon TAA)
19 gene 12.011588 12.011673 negative MGI_C57BL6J_4413734 n-TRtct1 NCBI_Gene:102467472 MGI:4413734 tRNA gene nuclear encoded tRNA arginine 1 (anticodon TCT)
19 gene 12.011931 12.012003 positive MGI_C57BL6J_4414104 n-TVtac1 NCBI_Gene:102467626 MGI:4414104 tRNA gene nuclear encoded tRNA valine 1 (anticodon TAC)
19 gene 12.012266 12.012338 positive MGI_C57BL6J_4414105 n-TVtac2 NCBI_Gene:102467409 MGI:4414105 tRNA gene nuclear encoded tRNA valine 2 (anticodon TAC)
19 pseudogene 12.020175 12.020403 positive MGI_C57BL6J_3031255 Olfr1421-ps1 NCBI_Gene:404514,ENSEMBL:ENSMUSG00000109030 MGI:3031255 pseudogene olfactory receptor 1421, pseudogene 1
19 pseudogene 12.020505 12.020562 negative MGI_C57BL6J_5753691 Gm45115 ENSEMBL:ENSMUSG00000109047 MGI:5753691 pseudogene predicted gene 45115
19 pseudogene 12.020614 12.021763 negative MGI_C57BL6J_3031256 Olfr1422-ps1 NCBI_Gene:258005,ENSEMBL:ENSMUSG00000108947 MGI:3031256 pseudogene olfactory receptor 1422, pseudogene 1
19 pseudogene 12.026646 12.026920 negative MGI_C57BL6J_5753692 Gm45116 ENSEMBL:ENSMUSG00000109223 MGI:5753692 pseudogene predicted gene 45116
19 gene 12.031787 12.041317 negative MGI_C57BL6J_3031257 Olfr1423 NCBI_Gene:258675,ENSEMBL:ENSMUSG00000067529 MGI:3031257 protein coding gene olfactory receptor 1423
19 pseudogene 12.037731 12.037824 positive MGI_C57BL6J_5753435 Gm44859 ENSEMBL:ENSMUSG00000109417 MGI:5753435 pseudogene predicted gene 44859
19 gene 12.058624 12.062682 negative MGI_C57BL6J_3031258 Olfr1424 NCBI_Gene:258676,ENSEMBL:ENSMUSG00000067528 MGI:3031258 protein coding gene olfactory receptor 1424
19 gene 12.073234 12.077731 negative MGI_C57BL6J_3031259 Olfr1425 NCBI_Gene:258155,ENSEMBL:ENSMUSG00000067526 MGI:3031259 protein coding gene olfactory receptor 1425
19 gene 12.086746 12.092013 negative MGI_C57BL6J_3031260 Olfr1426 NCBI_Gene:258805,ENSEMBL:ENSMUSG00000044994 MGI:3031260 protein coding gene olfactory receptor 1426
19 gene 12.098006 12.103334 negative MGI_C57BL6J_3031261 Olfr1427 NCBI_Gene:258674,ENSEMBL:ENSMUSG00000067525 MGI:3031261 protein coding gene olfactory receptor 1427
19 gene 12.107716 12.115897 negative MGI_C57BL6J_3031262 Olfr1428 NCBI_Gene:258673,ENSEMBL:ENSMUSG00000067524 MGI:3031262 protein coding gene olfactory receptor 1428
19 gene 12.117996 12.123203 negative MGI_C57BL6J_2153205 Olfr76 NCBI_Gene:258677,ENSEMBL:ENSMUSG00000067522 MGI:2153205 protein coding gene olfactory receptor 76
19 pseudogene 12.164424 12.170112 negative MGI_C57BL6J_3031389 Olfr1555-ps1 NCBI_Gene:257954,ENSEMBL:ENSMUSG00000108889 MGI:3031389 pseudogene olfactory receptor 1555, pseudogene 1
19 pseudogene 12.177607 12.178523 negative MGI_C57BL6J_3031264 Olfr1430-ps1 NCBI_Gene:257992,ENSEMBL:ENSMUSG00000109410 MGI:3031264 pseudogene olfactory receptor 1430, pseudogene 1
19 gene 12.200634 12.212191 positive MGI_C57BL6J_3031265 Olfr1431 NCBI_Gene:258409,ENSEMBL:ENSMUSG00000094133 MGI:3031265 protein coding gene olfactory receptor 1431
19 gene 12.227755 12.232596 negative MGI_C57BL6J_3031266 Olfr1432 NCBI_Gene:257961,ENSEMBL:ENSMUSG00000109022 MGI:3031266 protein coding gene olfactory receptor 1432
19 gene 12.240721 12.241659 negative MGI_C57BL6J_3030096 Olfr262 NCBI_Gene:258683,ENSEMBL:ENSMUSG00000067519 MGI:3030096 protein coding gene olfactory receptor 262
19 pseudogene 12.247491 12.247646 negative MGI_C57BL6J_5477358 Gm26864 ENSEMBL:ENSMUSG00000097646 MGI:5477358 pseudogene predicted gene, 26864
19 gene 12.261032 12.270387 positive MGI_C57BL6J_3030069 Olfr235 NCBI_Gene:258681,ENSEMBL:ENSMUSG00000060049 MGI:3030069 protein coding gene olfactory receptor 235
19 pseudogene 12.273011 12.275157 positive MGI_C57BL6J_5009988 Gm17802 NCBI_Gene:100286833,ENSEMBL:ENSMUSG00000118093 MGI:5009988 pseudogene predicted gene, 17802
19 gene 12.279854 12.285626 positive MGI_C57BL6J_3031268 Olfr1434 NCBI_Gene:258680,ENSEMBL:ENSMUSG00000095640 MGI:3031268 protein coding gene olfactory receptor 1434
19 pseudogene 12.289854 12.290306 negative MGI_C57BL6J_3031269 Olfr1435-ps1 NCBI_Gene:258004,ENSEMBL:ENSMUSG00000109433 MGI:3031269 pseudogene olfactory receptor 1435, pseudogene 1
19 gene 12.298183 12.299130 negative MGI_C57BL6J_3031270 Olfr1436 NCBI_Gene:258682,ENSEMBL:ENSMUSG00000067513 MGI:3031270 protein coding gene olfactory receptor 1436
19 pseudogene 12.314874 12.315027 negative MGI_C57BL6J_5753434 Gm44858 ENSEMBL:ENSMUSG00000109229 MGI:5753434 pseudogene predicted gene 44858
19 gene 12.319207 12.325101 negative MGI_C57BL6J_3031271 Olfr1437 NCBI_Gene:258117,ENSEMBL:ENSMUSG00000096436 MGI:3031271 protein coding gene olfactory receptor 1437
19 pseudogene 12.329422 12.335910 negative MGI_C57BL6J_3031272 Olfr1438-ps1 NCBI_Gene:258116,ENSEMBL:ENSMUSG00000109328 MGI:3031272 pseudogene olfactory receptor 1438, pseudogene 1
19 pseudogene 12.339738 12.341142 negative MGI_C57BL6J_3031273 Olfr1439-ps1 NCBI_Gene:258015,ENSEMBL:ENSMUSG00000109007 MGI:3031273 pseudogene olfactory receptor 1439, pseudogene 1
19 gene 12.387279 12.401584 positive MGI_C57BL6J_3031274 Olfr1440 NCBI_Gene:258679,ENSEMBL:ENSMUSG00000046650 MGI:3031274 protein coding gene olfactory receptor 1440
19 gene 12.417433 12.423569 positive MGI_C57BL6J_3031275 Olfr1441 NCBI_Gene:258678,ENSEMBL:ENSMUSG00000050815 MGI:3031275 protein coding gene olfactory receptor 1441
19 gene 12.427905 12.432110 positive MGI_C57BL6J_1860266 Pfpl NCBI_Gene:56093,ENSEMBL:ENSMUSG00000040065 MGI:1860266 protein coding gene pore forming protein-like
19 gene 12.460709 12.465285 positive MGI_C57BL6J_1333743 Mpeg1 NCBI_Gene:17476,ENSEMBL:ENSMUSG00000046805 MGI:1333743 protein coding gene macrophage expressed gene 1
19 gene 12.466329 12.502201 negative MGI_C57BL6J_2672905 Dtx4 NCBI_Gene:207521,ENSEMBL:ENSMUSG00000039982 MGI:2672905 protein coding gene deltex 4, E3 ubiquitin ligase
19 gene 12.517915 12.596566 negative MGI_C57BL6J_3698434 A330040F15Rik NCBI_Gene:74333,ENSEMBL:ENSMUSG00000086213 MGI:3698434 lncRNA gene RIKEN cDNA A330040F15 gene
19 gene 12.517921 12.524338 negative MGI_C57BL6J_5590367 Gm31208 NCBI_Gene:102633365 MGI:5590367 lncRNA gene predicted gene, 31208
19 gene 12.519800 12.523576 positive MGI_C57BL6J_6096066 Gm47243 ENSEMBL:ENSMUSG00000114644 MGI:6096066 lncRNA gene predicted gene, 47243
19 pseudogene 12.528755 12.530540 negative MGI_C57BL6J_3643874 Gm6545 NCBI_Gene:625046,ENSEMBL:ENSMUSG00000111118 MGI:3643874 pseudogene predicted gene 6545
19 gene 12.539588 12.540823 negative MGI_C57BL6J_6096064 Gm47242 ENSEMBL:ENSMUSG00000114761 MGI:6096064 lncRNA gene predicted gene, 47242
19 gene 12.545740 12.589769 positive MGI_C57BL6J_1915508 Fam111a NCBI_Gene:107373,ENSEMBL:ENSMUSG00000024691 MGI:1915508 protein coding gene family with sequence similarity 111, member A
19 pseudogene 12.568188 12.568836 negative MGI_C57BL6J_3826552 Gm16274 NCBI_Gene:100418049,ENSEMBL:ENSMUSG00000084836 MGI:3826552 pseudogene predicted gene 16274
19 gene 12.595749 12.598309 positive MGI_C57BL6J_1921583 4122401K19Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 4122401K19 gene
19 gene 12.599974 12.628251 positive MGI_C57BL6J_3643569 Gm4952 NCBI_Gene:240549,ENSEMBL:ENSMUSG00000071633 MGI:3643569 protein coding gene predicted gene 4952
19 gene 12.633308 12.653911 positive MGI_C57BL6J_2147502 Glyat NCBI_Gene:107146,ENSEMBL:ENSMUSG00000063683 MGI:2147502 protein coding gene glycine-N-acyltransferase
19 gene 12.665255 12.665361 positive MGI_C57BL6J_5454298 Gm24521 ENSEMBL:ENSMUSG00000065892 MGI:5454298 snRNA gene predicted gene, 24521
19 gene 12.670439 12.677277 positive MGI_C57BL6J_3031276 Olfr1442 NCBI_Gene:258692,ENSEMBL:ENSMUSG00000044441 MGI:3031276 protein coding gene olfactory receptor 1442
19 gene 12.678112 12.683851 positive MGI_C57BL6J_3031277 Olfr1443 NCBI_Gene:258693,ENSEMBL:ENSMUSG00000045030 MGI:3031277 protein coding gene olfactory receptor 1443
19 pseudogene 12.681771 12.681915 positive MGI_C57BL6J_6215285 Gm49772 ENSEMBL:ENSMUSG00000109309 MGI:6215285 pseudogene predicted gene, 49772
19 gene 12.695786 12.719902 positive MGI_C57BL6J_1928492 Keg1 NCBI_Gene:64697,ENSEMBL:ENSMUSG00000024694 MGI:1928492 protein coding gene kidney expressed gene 1
19 gene 12.706055 12.721247 negative MGI_C57BL6J_3802141 Gm15962 ENSEMBL:ENSMUSG00000084981 MGI:3802141 lncRNA gene predicted gene 15962
19 pseudogene 12.713227 12.713948 negative MGI_C57BL6J_5010728 Gm18543 NCBI_Gene:100417340 MGI:5010728 pseudogene predicted gene, 18543
19 gene 12.763528 12.765632 negative MGI_C57BL6J_88439 Cntf NCBI_Gene:12803,ENSEMBL:ENSMUSG00000079415 MGI:88439 protein coding gene ciliary neurotrophic factor
19 gene 12.763528 12.796123 negative MGI_C57BL6J_3845910 Gm44505 NCBI_Gene:664779 MGI:3845910 lncRNA gene predicted readthrough transcript (NMD candidate), 44505
19 gene 12.763660 12.796126 negative MGI_C57BL6J_104854 Zfp91 NCBI_Gene:109910,ENSEMBL:ENSMUSG00000024695 MGI:104854 protein coding gene zinc finger protein 91
19 gene 12.796193 12.833808 positive MGI_C57BL6J_2147677 Lpxn NCBI_Gene:107321,ENSEMBL:ENSMUSG00000024696 MGI:2147677 protein coding gene leupaxin
19 gene 12.846682 12.847424 positive MGI_C57BL6J_3646958 Gm5244 NCBI_Gene:383436,ENSEMBL:ENSMUSG00000091014 MGI:3646958 protein coding gene predicted pseudogene 5244
19 gene 12.857283 12.863440 positive MGI_C57BL6J_3031278 Olfr1444 NCBI_Gene:258697,ENSEMBL:ENSMUSG00000046272 MGI:3031278 protein coding gene olfactory receptor 1444
19 gene 12.883855 12.884855 positive MGI_C57BL6J_3031279 Olfr1445 NCBI_Gene:258694,ENSEMBL:ENSMUSG00000045126 MGI:3031279 protein coding gene olfactory receptor 1445
19 gene 12.888266 12.893524 negative MGI_C57BL6J_3031280 Olfr1446 NCBI_Gene:258699,ENSEMBL:ENSMUSG00000057817 MGI:3031280 protein coding gene olfactory receptor 1446
19 gene 12.899434 12.903743 negative MGI_C57BL6J_3031281 Olfr1447 NCBI_Gene:258698,ENSEMBL:ENSMUSG00000060303 MGI:3031281 protein coding gene olfactory receptor 1447
19 pseudogene 12.905231 12.906993 positive MGI_C57BL6J_3645436 Gm5512 NCBI_Gene:433224,ENSEMBL:ENSMUSG00000112693 MGI:3645436 pseudogene predicted gene 5512
19 gene 12.916661 12.924419 negative MGI_C57BL6J_3031282 Olfr1448 NCBI_Gene:258696,ENSEMBL:ENSMUSG00000048456 MGI:3031282 protein coding gene olfactory receptor 1448
19 gene 12.930840 12.935752 positive MGI_C57BL6J_3031283 Olfr1449 NCBI_Gene:258300,ENSEMBL:ENSMUSG00000049498 MGI:3031283 protein coding gene olfactory receptor 1449
19 gene 12.950258 12.956406 positive MGI_C57BL6J_3031284 Olfr1450 NCBI_Gene:258368,ENSEMBL:ENSMUSG00000062892 MGI:3031284 protein coding gene olfactory receptor 1450
19 gene 12.995014 13.000417 positive MGI_C57BL6J_3031285 Olfr1451 NCBI_Gene:258700,ENSEMBL:ENSMUSG00000046913 MGI:3031285 protein coding gene olfactory receptor 1451
19 pseudogene 13.011704 13.012668 negative MGI_C57BL6J_5011317 Gm19132 NCBI_Gene:100418307 MGI:5011317 pseudogene predicted gene, 19132
19 pseudogene 13.016225 13.017149 positive MGI_C57BL6J_3031286 Olfr1452-ps1 NCBI_Gene:258126,ENSEMBL:ENSMUSG00000109148 MGI:3031286 polymorphic pseudogene olfactory receptor 1452, pseudogene 1
19 gene 13.027404 13.028327 negative MGI_C57BL6J_3031287 Olfr1453 NCBI_Gene:258695,ENSEMBL:ENSMUSG00000094755 MGI:3031287 protein coding gene olfactory receptor 1453
19 gene 13.060610 13.067157 positive MGI_C57BL6J_3031288 Olfr1454 NCBI_Gene:258687,ENSEMBL:ENSMUSG00000094986 MGI:3031288 protein coding gene olfactory receptor 1454
19 pseudogene 13.068904 13.069677 positive MGI_C57BL6J_3031289 Olfr1455-ps1 NCBI_Gene:404515,ENSEMBL:ENSMUSG00000109126 MGI:3031289 pseudogene olfactory receptor 1455, pseudogene 1
19 pseudogene 13.078637 13.079335 negative MGI_C57BL6J_3031290 Olfr1456-ps1 NCBI_Gene:404516,ENSEMBL:ENSMUSG00000067482 MGI:3031290 pseudogene olfactory receptor 1456, pseudogene 1
19 gene 13.093379 13.097891 negative MGI_C57BL6J_3031291 Olfr1457 NCBI_Gene:258568,ENSEMBL:ENSMUSG00000061637 MGI:3031291 protein coding gene olfactory receptor 1457
19 gene 13.101593 13.106775 negative MGI_C57BL6J_3031292 Olfr1458 NCBI_Gene:667271,ENSEMBL:ENSMUSG00000062844 MGI:3031292 protein coding gene olfactory receptor 1458
19 gene 13.138021 13.149549 negative MGI_C57BL6J_3031293 Olfr1459 NCBI_Gene:258684,ENSEMBL:ENSMUSG00000057503 MGI:3031293 protein coding gene olfactory receptor 1459
19 pseudogene 13.158191 13.159316 positive MGI_C57BL6J_3031294 Olfr1460-ps1 NCBI_Gene:258118,ENSEMBL:ENSMUSG00000109415 MGI:3031294 pseudogene olfactory receptor 1460, pseudogene 1
19 gene 13.163000 13.168130 positive MGI_C57BL6J_3031295 Olfr1461 NCBI_Gene:258299,ENSEMBL:ENSMUSG00000045883 MGI:3031295 protein coding gene olfactory receptor 1461
19 gene 13.185734 13.193775 positive MGI_C57BL6J_3031296 Olfr1462 NCBI_Gene:258688,ENSEMBL:ENSMUSG00000094721 MGI:3031296 protein coding gene olfactory receptor 1462
19 gene 13.231328 13.236400 positive MGI_C57BL6J_3031297 Olfr1463 NCBI_Gene:258120,ENSEMBL:ENSMUSG00000096365 MGI:3031297 protein coding gene olfactory receptor 1463
19 pseudogene 13.282134 13.283056 negative MGI_C57BL6J_3031298 Olfr1464-ps1 NCBI_Gene:667300,ENSEMBL:ENSMUSG00000109100 MGI:3031298 polymorphic pseudogene olfactory receptor 1464, pseudogene 1
19 gene 13.301001 13.301107 negative MGI_C57BL6J_5452220 Gm22443 ENSEMBL:ENSMUSG00000064824 MGI:5452220 snRNA gene predicted gene, 22443
19 gene 13.312768 13.315541 negative MGI_C57BL6J_3031299 Olfr1465 NCBI_Gene:258121,ENSEMBL:ENSMUSG00000062199 MGI:3031299 protein coding gene olfactory receptor 1465
19 gene 13.338862 13.343572 positive MGI_C57BL6J_3031300 Olfr1466 NCBI_Gene:258689,ENSEMBL:ENSMUSG00000096485 MGI:3031300 protein coding gene olfactory receptor 1466
19 gene 13.362236 13.368054 positive MGI_C57BL6J_3031301 Olfr1467 NCBI_Gene:258686,ENSEMBL:ENSMUSG00000049015 MGI:3031301 protein coding gene olfactory receptor 1467
19 pseudogene 13.371854 13.376066 positive MGI_C57BL6J_3031302 Olfr1468-ps1 NCBI_Gene:258192,ENSEMBL:ENSMUSG00000109544 MGI:3031302 polymorphic pseudogene olfactory receptor 1468, pseudogene 1
19 pseudogene 13.403157 13.403640 positive MGI_C57BL6J_5753425 Gm44849 ENSEMBL:ENSMUSG00000108881 MGI:5753425 pseudogene predicted gene 44849
19 gene 13.407849 13.414540 positive MGI_C57BL6J_3031303 Olfr1469 NCBI_Gene:258690,ENSEMBL:ENSMUSG00000063777 MGI:3031303 protein coding gene olfactory receptor 1469
19 pseudogene 13.434147 13.435095 negative MGI_C57BL6J_3031304 Olfr1470-ps1 NCBI_Gene:258119,ENSEMBL:ENSMUSG00000109230 MGI:3031304 pseudogene olfactory receptor 1470, pseudogene 1
19 gene 13.443409 13.451527 positive MGI_C57BL6J_3031305 Olfr1471 NCBI_Gene:258231,ENSEMBL:ENSMUSG00000096320 MGI:3031305 protein coding gene olfactory receptor 1471
19 gene 13.453280 13.456086 negative MGI_C57BL6J_3031306 Olfr1472 NCBI_Gene:258685,ENSEMBL:ENSMUSG00000095189 MGI:3031306 protein coding gene olfactory receptor 1472
19 pseudogene 13.462678 13.463635 negative MGI_C57BL6J_3031307 Olfr1473-ps1 NCBI_Gene:258124,ENSEMBL:ENSMUSG00000109573 MGI:3031307 pseudogene olfactory receptor 1473, pseudogene 1
19 gene 13.469565 13.472157 positive MGI_C57BL6J_3031308 Olfr1474 NCBI_Gene:258123,ENSEMBL:ENSMUSG00000096273 MGI:3031308 protein coding gene olfactory receptor 1474
19 gene 13.479252 13.480196 negative MGI_C57BL6J_3031309 Olfr1475 NCBI_Gene:258298,ENSEMBL:ENSMUSG00000096708 MGI:3031309 protein coding gene olfactory receptor 1475
19 pseudogene 13.488309 13.488741 positive MGI_C57BL6J_3031310 Olfr1476-ps1 NCBI_Gene:404517,ENSEMBL:ENSMUSG00000109189 MGI:3031310 pseudogene olfactory receptor 1476, pseudogene 1
19 gene 13.500546 13.506192 positive MGI_C57BL6J_3031311 Olfr1477 NCBI_Gene:258691,ENSEMBL:ENSMUSG00000071629 MGI:3031311 protein coding gene olfactory receptor 1477
19 pseudogene 13.505325 13.505715 positive MGI_C57BL6J_3031312 Olfr1478-ps1 NCBI_Gene:404518,ENSEMBL:ENSMUSG00000109184 MGI:3031312 pseudogene olfactory receptor 1478, pseudogene 1
19 pseudogene 13.511433 13.511931 positive MGI_C57BL6J_3031313 Olfr1479-ps1 NCBI_Gene:404519,ENSEMBL:ENSMUSG00000108887 MGI:3031313 pseudogene olfactory receptor 1479, pseudogene 1
19 pseudogene 13.512553 13.515138 negative MGI_C57BL6J_3781367 Gm3188 NCBI_Gene:100041185,ENSEMBL:ENSMUSG00000118174 MGI:3781367 pseudogene predicted gene 3188
19 gene 13.527913 13.531275 positive MGI_C57BL6J_3031314 Olfr1480 NCBI_Gene:404339,ENSEMBL:ENSMUSG00000095484 MGI:3031314 protein coding gene olfactory receptor 1480
19 pseudogene 13.535390 13.535725 positive MGI_C57BL6J_3031315 Olfr1481-ps1 NCBI_Gene:404520,ENSEMBL:ENSMUSG00000108945 MGI:3031315 pseudogene olfactory receptor 1481, pseudogene 1
19 pseudogene 13.563036 13.563213 negative MGI_C57BL6J_3031316 Olfr1482-ps1 NCBI_Gene:404521,ENSEMBL:ENSMUSG00000109319 MGI:3031316 pseudogene olfactory receptor 1482, pseudogene 1
19 pseudogene 13.566758 13.567178 positive MGI_C57BL6J_3031317 Olfr1483-ps1 NCBI_Gene:404522,ENSEMBL:ENSMUSG00000108974 MGI:3031317 pseudogene olfactory receptor 1483, pseudogene 1
19 gene 13.583511 13.588832 positive MGI_C57BL6J_3031318 Olfr1484 NCBI_Gene:258288,ENSEMBL:ENSMUSG00000096289 MGI:3031318 protein coding gene olfactory receptor 1484
19 pseudogene 13.588290 13.588659 positive MGI_C57BL6J_3031319 Olfr1485-ps1 NCBI_Gene:404523,ENSEMBL:ENSMUSG00000109496 MGI:3031319 pseudogene olfactory receptor 1485, pseudogene 1
19 pseudogene 13.593860 13.594231 positive MGI_C57BL6J_3031320 Olfr1486-ps1 NCBI_Gene:404524,ENSEMBL:ENSMUSG00000109343 MGI:3031320 pseudogene olfactory receptor 1486, pseudogene 1
19 pseudogene 13.595018 13.596063 negative MGI_C57BL6J_3779948 Gm9538 NCBI_Gene:671653 MGI:3779948 pseudogene predicted gene 9538
19 gene 13.599660 13.599768 negative MGI_C57BL6J_5452100 Gm22323 ENSEMBL:ENSMUSG00000094077 MGI:5452100 miRNA gene predicted gene, 22323
19 gene 13.604999 13.605107 negative MGI_C57BL6J_5453708 Gm23931 ENSEMBL:ENSMUSG00000096298 MGI:5453708 miRNA gene predicted gene, 23931
19 gene 13.617375 13.623072 positive MGI_C57BL6J_3031321 Olfr1487 NCBI_Gene:258629,ENSEMBL:ENSMUSG00000094846 MGI:3031321 protein coding gene olfactory receptor 1487
19 pseudogene 13.625625 13.625944 positive MGI_C57BL6J_3031322 Olfr1488-ps1 NCBI_Gene:257768,ENSEMBL:ENSMUSG00000109285 MGI:3031322 pseudogene olfactory receptor 1488, pseudogene 1
19 gene 13.631621 13.643987 positive MGI_C57BL6J_3031323 Olfr1489 NCBI_Gene:258628,ENSEMBL:ENSMUSG00000045678 MGI:3031323 protein coding gene olfactory receptor 1489
19 gene 13.635583 13.635714 negative MGI_C57BL6J_5453901 Gm24124 ENSEMBL:ENSMUSG00000077291 MGI:5453901 snoRNA gene predicted gene, 24124
19 gene 13.651091 13.659545 positive MGI_C57BL6J_3031324 Olfr1490 NCBI_Gene:258098,ENSEMBL:ENSMUSG00000061387 MGI:3031324 protein coding gene olfactory receptor 1490
19 gene 13.697268 13.706127 positive MGI_C57BL6J_3031325 Olfr1491 NCBI_Gene:258342,ENSEMBL:ENSMUSG00000051156 MGI:3031325 protein coding gene olfactory receptor 1491
19 pseudogene 13.718013 13.718877 positive MGI_C57BL6J_3031326 Olfr1492-ps1 NCBI_Gene:404526,ENSEMBL:ENSMUSG00000109527 MGI:3031326 pseudogene olfactory receptor 1492, pseudogene 1
19 pseudogene 13.723278 13.727983 positive MGI_C57BL6J_3031327 Olfr1493-ps1 NCBI_Gene:258735,ENSEMBL:ENSMUSG00000109520 MGI:3031327 pseudogene olfactory receptor 1493, pseudogene 1
19 gene 13.739728 13.750479 positive MGI_C57BL6J_3031328 Olfr1494 NCBI_Gene:258992,ENSEMBL:ENSMUSG00000050865 MGI:3031328 protein coding gene olfactory receptor 1494
19 gene 13.764606 13.770248 positive MGI_C57BL6J_3031329 Olfr1495 NCBI_Gene:258341,ENSEMBL:ENSMUSG00000047207 MGI:3031329 protein coding gene olfactory receptor 1495
19 gene 13.777878 13.782920 positive MGI_C57BL6J_3031330 Olfr1496 NCBI_Gene:258991,ENSEMBL:ENSMUSG00000048356 MGI:3031330 protein coding gene olfactory receptor 1496
19 pseudogene 13.791965 13.792514 positive MGI_C57BL6J_5011403 Gm19218 NCBI_Gene:100418446 MGI:5011403 pseudogene predicted gene, 19218
19 gene 13.794324 13.798202 negative MGI_C57BL6J_3031331 Olfr1497 NCBI_Gene:258736,ENSEMBL:ENSMUSG00000044040 MGI:3031331 protein coding gene olfactory receptor 1497
19 pseudogene 13.804428 13.806257 negative MGI_C57BL6J_3031332 Olfr1498-ps1 NCBI_Gene:258217,ENSEMBL:ENSMUSG00000109530 MGI:3031332 pseudogene olfactory receptor 1498, pseudogene 1
19 gene 13.814275 13.819447 negative MGI_C57BL6J_3031333 Olfr1499 NCBI_Gene:258792,ENSEMBL:ENSMUSG00000045395 MGI:3031333 protein coding gene olfactory receptor 1499
19 gene 13.826882 13.830488 negative MGI_C57BL6J_3031334 Olfr1500 NCBI_Gene:258097,ENSEMBL:ENSMUSG00000054526 MGI:3031334 protein coding gene olfactory receptor 1500
19 gene 13.835033 13.850692 negative MGI_C57BL6J_3031335 Olfr1501 NCBI_Gene:258626,ENSEMBL:ENSMUSG00000057270 MGI:3031335 protein coding gene olfactory receptor 1501
19 gene 13.861795 13.862745 positive MGI_C57BL6J_3031336 Olfr1502 NCBI_Gene:258793,ENSEMBL:ENSMUSG00000056858 MGI:3031336 protein coding gene olfactory receptor 1502
19 pseudogene 13.877451 13.878253 positive MGI_C57BL6J_3031337 Olfr1503-ps1 NCBI_Gene:404527,ENSEMBL:ENSMUSG00000058078 MGI:3031337 pseudogene olfactory receptor 1503, pseudogene 1
19 gene 13.886920 13.897928 negative MGI_C57BL6J_3031338 Olfr1504 NCBI_Gene:258627,ENSEMBL:ENSMUSG00000059105 MGI:3031338 protein coding gene olfactory receptor 1504
19 gene 13.913530 13.921866 positive MGI_C57BL6J_3031339 Olfr1505 NCBI_Gene:258151,ENSEMBL:ENSMUSG00000062314 MGI:3031339 protein coding gene olfactory receptor 1505
19 pseudogene 13.938563 13.939288 positive MGI_C57BL6J_3761697 Vmn2r-ps135 NCBI_Gene:100124582 MGI:3761697 pseudogene vomeronasal 2, receptor, pseudogene 135
19 pseudogene 14.017583 14.018371 negative MGI_C57BL6J_5504108 Gm26993 ENSEMBL:ENSMUSG00000098074 MGI:5504108 pseudogene predicted gene, 26993
19 gene 14.083631 14.084378 positive MGI_C57BL6J_1922297 4930504B16Rik NA NA unclassified gene RIKEN cDNA 4930504B16 gene
19 gene 14.090247 14.096731 negative MGI_C57BL6J_5590490 Gm31331 NCBI_Gene:102633524 MGI:5590490 lncRNA gene predicted gene, 31331
19 gene 14.397487 14.435950 negative MGI_C57BL6J_3647677 Gm8630 NCBI_Gene:667433 MGI:3647677 unclassified gene predicted gene 8630
19 gene 14.448072 14.598183 negative MGI_C57BL6J_104633 Tle4 NCBI_Gene:21888,ENSEMBL:ENSMUSG00000024642 MGI:104633 protein coding gene transducin-like enhancer of split 4
19 gene 14.564458 14.566993 positive MGI_C57BL6J_5590600 Gm31441 NCBI_Gene:102633674 MGI:5590600 lncRNA gene predicted gene, 31441
19 gene 14.658667 14.658933 positive MGI_C57BL6J_5611225 Gm37997 ENSEMBL:ENSMUSG00000103488 MGI:5611225 unclassified gene predicted gene, 37997
19 gene 14.718358 14.718480 negative MGI_C57BL6J_5455803 Gm26026 ENSEMBL:ENSMUSG00000084675 MGI:5455803 snRNA gene predicted gene, 26026
19 pseudogene 14.959002 14.960782 negative MGI_C57BL6J_3645437 Gm5513 NCBI_Gene:433225,ENSEMBL:ENSMUSG00000063586 MGI:3645437 pseudogene predicted pseudogene 5513
19 pseudogene 15.193521 15.194233 negative MGI_C57BL6J_3647037 Gm7159 NCBI_Gene:635497 MGI:3647037 pseudogene predicted gene 7159
19 gene 15.290167 15.340387 negative MGI_C57BL6J_5826282 Gm46645 NCBI_Gene:108168406 MGI:5826282 lncRNA gene predicted gene, 46645
19 pseudogene 15.362335 15.362870 positive MGI_C57BL6J_104962 Pomc-ps1 NCBI_Gene:18977 MGI:104962 pseudogene pro-opiomelanocortin, pseudogene 1
19 pseudogene 15.458964 15.459672 negative MGI_C57BL6J_5011482 Selenok-ps3 NCBI_Gene:100502633 MGI:5011482 pseudogene selenoprotein K, pseudogene 3
19 gene 15.599131 15.632101 positive MGI_C57BL6J_5590753 Gm31594 NCBI_Gene:102633870 MGI:5590753 lncRNA gene predicted gene, 31594
19 gene 15.636548 15.662923 positive MGI_C57BL6J_5826302 Gm46665 NCBI_Gene:108168427 MGI:5826302 lncRNA gene predicted gene, 46665
19 gene 15.659946 15.664346 negative MGI_C57BL6J_5590892 Gm31733 NCBI_Gene:102634054 MGI:5590892 lncRNA gene predicted gene, 31733
19 gene 15.680004 15.680110 positive MGI_C57BL6J_5454096 Gm24319 ENSEMBL:ENSMUSG00000094850 MGI:5454096 snRNA gene predicted gene, 24319
19 gene 15.803058 15.807653 positive MGI_C57BL6J_6303228 Gm50348 ENSEMBL:ENSMUSG00000117995 MGI:6303228 lncRNA gene predicted gene, 50348
19 gene 15.904678 15.947337 negative MGI_C57BL6J_2183441 Psat1 NCBI_Gene:107272,ENSEMBL:ENSMUSG00000024640 MGI:2183441 protein coding gene phosphoserine aminotransferase 1
19 pseudogene 15.943610 15.944165 positive MGI_C57BL6J_3781507 Gm3329 ENSEMBL:ENSMUSG00000090147 MGI:3781507 pseudogene predicted gene 3329
19 gene 15.955770 15.985016 negative MGI_C57BL6J_1924386 Cep78 NCBI_Gene:208518,ENSEMBL:ENSMUSG00000041491 MGI:1924386 protein coding gene centrosomal protein 78
19 gene 15.985075 16.010912 positive MGI_C57BL6J_3041192 C130060C02Rik NCBI_Gene:100502653,ENSEMBL:ENSMUSG00000097557 MGI:3041192 lncRNA gene RIKEN cDNA C130060C02 gene
19 pseudogene 16.025451 16.025762 positive MGI_C57BL6J_3646957 Rpl37-ps1 NCBI_Gene:383438,ENSEMBL:ENSMUSG00000117711 MGI:3646957 pseudogene ribosomal protein 37, pseudogene 1
19 gene 16.064113 16.090591 positive MGI_C57BL6J_5591185 Gm32026 NCBI_Gene:102634445 MGI:5591185 lncRNA gene predicted gene, 32026
19 gene 16.132831 16.387463 positive MGI_C57BL6J_95776 Gnaq NCBI_Gene:14682,ENSEMBL:ENSMUSG00000024639 MGI:95776 protein coding gene guanine nucleotide binding protein, alpha q polypeptide
19 pseudogene 16.164098 16.170458 negative MGI_C57BL6J_2442009 E030024N20Rik NCBI_Gene:595139,ENSEMBL:ENSMUSG00000057990 MGI:2442009 pseudogene RIKEN cDNA E030024N20 gene
19 pseudogene 16.266432 16.267635 negative MGI_C57BL6J_3642135 Gm10819 NCBI_Gene:624438,ENSEMBL:ENSMUSG00000075268 MGI:3642135 pseudogene predicted gene 10819
19 pseudogene 16.277779 16.278974 positive MGI_C57BL6J_4937895 Gm17068 NCBI_Gene:100158259,ENSEMBL:ENSMUSG00000078528 MGI:4937895 pseudogene predicted gene 17068
19 gene 16.314892 16.315004 negative MGI_C57BL6J_5531410 Mir496b miRBase:MI0021942,NCBI_Gene:102465218,ENSEMBL:ENSMUSG00000098718 MGI:5531410 miRNA gene microRNA 496b
19 pseudogene 16.413431 16.414290 positive MGI_C57BL6J_5011497 Gm19312 NCBI_Gene:100502667,ENSEMBL:ENSMUSG00000118142 MGI:5011497 pseudogene predicted gene, 19312
19 gene 16.415826 16.422829 negative MGI_C57BL6J_6303250 Gm50362 ENSEMBL:ENSMUSG00000118033 MGI:6303250 lncRNA gene predicted gene, 50362
19 gene 16.435667 16.610820 positive MGI_C57BL6J_95769 Gna14 NCBI_Gene:14675,ENSEMBL:ENSMUSG00000024697 MGI:95769 protein coding gene guanine nucleotide binding protein, alpha 14
19 pseudogene 16.477107 16.491122 negative MGI_C57BL6J_3643833 Gm8222 NCBI_Gene:666665,ENSEMBL:ENSMUSG00000117699 MGI:3643833 pseudogene predicted gene 8222
19 pseudogene 16.572160 16.572468 negative MGI_C57BL6J_6303252 Gm50363 ENSEMBL:ENSMUSG00000118023 MGI:6303252 pseudogene predicted gene, 50363
19 gene 16.580085 16.583462 negative MGI_C57BL6J_5624696 Gm41811 NCBI_Gene:105246537 MGI:5624696 lncRNA gene predicted gene, 41811
19 gene 16.612196 16.614869 negative MGI_C57BL6J_2442532 E230008J23Rik NA NA unclassified gene RIKEN cDNA E230008J23 gene
19 gene 16.615366 16.781878 negative MGI_C57BL6J_2444304 Vps13a NCBI_Gene:271564,ENSEMBL:ENSMUSG00000046230 MGI:2444304 protein coding gene vacuolar protein sorting 13A
19 pseudogene 16.715686 16.716289 positive MGI_C57BL6J_5591415 Gm32256 NCBI_Gene:102634749,ENSEMBL:ENSMUSG00000114931 MGI:5591415 pseudogene predicted gene, 32256
19 pseudogene 16.780547 16.781103 positive MGI_C57BL6J_3708646 Gm9806 ENSEMBL:ENSMUSG00000046388 MGI:3708646 pseudogene predicted gene 9806
19 gene 16.871092 16.925014 positive MGI_C57BL6J_5591500 Gm32341 NCBI_Gene:102634857,ENSEMBL:ENSMUSG00000118126 MGI:5591500 lncRNA gene predicted gene, 32341
19 gene 16.872316 16.873830 negative MGI_C57BL6J_1347468 Foxb2 NCBI_Gene:14240,ENSEMBL:ENSMUSG00000056829 MGI:1347468 protein coding gene forkhead box B2
19 gene 16.955670 17.223932 positive MGI_C57BL6J_1925004 Prune2 NCBI_Gene:353211,ENSEMBL:ENSMUSG00000039126 MGI:1925004 protein coding gene prune homolog 2
19 gene 17.056781 17.057187 negative MGI_C57BL6J_5531352 Gm27970 ENSEMBL:ENSMUSG00000098298 MGI:5531352 unclassified non-coding RNA gene predicted gene, 27970
19 gene 17.060137 17.060397 negative MGI_C57BL6J_5531178 Gm27796 ENSEMBL:ENSMUSG00000099316 MGI:5531178 unclassified non-coding RNA gene predicted gene, 27796
19 gene 17.238047 17.240669 negative MGI_C57BL6J_6303107 Gm50276 ENSEMBL:ENSMUSG00000117941 MGI:6303107 lncRNA gene predicted gene, 50276
19 gene 17.244010 17.256488 negative MGI_C57BL6J_6303109 Gm50277 ENSEMBL:ENSMUSG00000118367 MGI:6303109 lncRNA gene predicted gene, 50277
19 pseudogene 17.265984 17.266338 negative MGI_C57BL6J_6303114 Gm50280 ENSEMBL:ENSMUSG00000117946 MGI:6303114 pseudogene predicted gene, 50280
19 gene 17.326141 17.372844 negative MGI_C57BL6J_95676 Gcnt1 NCBI_Gene:14537,ENSEMBL:ENSMUSG00000038843 MGI:95676 protein coding gene glucosaminyl (N-acetyl) transferase 1, core 2
19 gene 17.394043 17.401349 positive MGI_C57BL6J_1914688 Rfk NCBI_Gene:54391,ENSEMBL:ENSMUSG00000024712 MGI:1914688 protein coding gene riboflavin kinase
19 gene 17.432314 17.837632 negative MGI_C57BL6J_97515 Pcsk5 NCBI_Gene:18552,ENSEMBL:ENSMUSG00000024713 MGI:97515 protein coding gene proprotein convertase subtilisin/kexin type 5
19 gene 17.536046 17.555945 positive MGI_C57BL6J_5624698 Gm41813 NCBI_Gene:105246539 MGI:5624698 lncRNA gene predicted gene, 41813
19 gene 17.573784 17.580645 positive MGI_C57BL6J_5624697 Gm41812 NCBI_Gene:105246538 MGI:5624697 lncRNA gene predicted gene, 41812
19 gene 17.632559 17.633491 negative MGI_C57BL6J_1925784 C430005N20Rik NA NA unclassified gene RIKEN cDNA C430005N20 gene
19 pseudogene 17.692763 17.693534 positive MGI_C57BL6J_5010004 Gm17819 NCBI_Gene:100310868,ENSEMBL:ENSMUSG00000118270 MGI:5010004 pseudogene predicted gene, 17819
19 gene 17.865317 17.865419 negative MGI_C57BL6J_5452657 Gm22880 ENSEMBL:ENSMUSG00000088370 MGI:5452657 snRNA gene predicted gene, 22880
19 gene 17.873829 17.893500 positive MGI_C57BL6J_6302952 Gm50181 ENSEMBL:ENSMUSG00000118079 MGI:6302952 lncRNA gene predicted gene, 50181
19 gene 17.891959 17.892051 negative MGI_C57BL6J_5452840 Gm23063 ENSEMBL:ENSMUSG00000076305 MGI:5452840 miRNA gene predicted gene, 23063
19 pseudogene 17.926557 17.928613 positive MGI_C57BL6J_2388571 Eef1a1-ps1 NCBI_Gene:235503,ENSEMBL:ENSMUSG00000117822 MGI:2388571 pseudogene eukaryotic translation elongation factor 1 alpha 1, pseudogene 1
19 gene 17.928111 17.928226 positive MGI_C57BL6J_5452838 Gm23061 ENSEMBL:ENSMUSG00000076303 MGI:5452838 miRNA gene predicted gene, 23061
19 gene 18.028111 18.040803 positive MGI_C57BL6J_6302954 Gm50182 ENSEMBL:ENSMUSG00000117687 MGI:6302954 lncRNA gene predicted gene, 50182
19 pseudogene 18.205148 18.205795 negative MGI_C57BL6J_5010795 Gm18610 NCBI_Gene:100417435,ENSEMBL:ENSMUSG00000117774 MGI:5010795 pseudogene predicted gene, 18610
19 pseudogene 18.480076 18.480748 positive MGI_C57BL6J_6302956 Gm50183 ENSEMBL:ENSMUSG00000118192 MGI:6302956 pseudogene predicted gene, 50183
19 gene 18.516137 18.631823 negative MGI_C57BL6J_700012 Ostf1 NCBI_Gene:20409,ENSEMBL:ENSMUSG00000024725 MGI:700012 protein coding gene osteoclast stimulating factor 1
19 pseudogene 18.565138 18.565755 positive MGI_C57BL6J_3779480 Rpl29-ps6 NCBI_Gene:383440 MGI:3779480 pseudogene ribosomal protein L29, pseudogene 6
19 pseudogene 18.581455 18.582228 positive MGI_C57BL6J_3647615 Gm8250 ENSEMBL:ENSMUSG00000080783 MGI:3647615 pseudogene predicted gene 8250
19 gene 18.627447 18.627921 negative MGI_C57BL6J_2147638 1110034N17Rik NA NA unclassified gene RIKEN cDNA 1110034N17 gene
19 gene 18.631950 18.652428 positive MGI_C57BL6J_2147434 Nmrk1 NCBI_Gene:225994,ENSEMBL:ENSMUSG00000037847 MGI:2147434 protein coding gene nicotinamide riboside kinase 1
19 gene 18.670734 18.707201 positive MGI_C57BL6J_1914633 Carnmt1 NCBI_Gene:67383,ENSEMBL:ENSMUSG00000024726 MGI:1914633 protein coding gene carnosine N-methyltransferase 1
19 gene 18.705798 18.707200 positive MGI_C57BL6J_1918901 4930447K04Rik NA NA unclassified gene RIKEN cDNA 4930447K04 gene
19 gene 18.712849 18.718429 positive MGI_C57BL6J_3583960 D030056L22Rik NCBI_Gene:225995,ENSEMBL:ENSMUSG00000047044 MGI:3583960 protein coding gene RIKEN cDNA D030056L22 gene
19 gene 18.730177 18.892521 positive MGI_C57BL6J_2675603 Trpm6 NCBI_Gene:225997,ENSEMBL:ENSMUSG00000024727 MGI:2675603 protein coding gene transient receptor potential cation channel, subfamily M, member 6
19 gene 18.731873 18.732776 negative MGI_C57BL6J_6302983 Gm50202 ENSEMBL:ENSMUSG00000117878 MGI:6302983 lncRNA gene predicted gene, 50202
19 gene 18.732741 18.732904 positive MGI_C57BL6J_5453015 Gm23238 ENSEMBL:ENSMUSG00000064941 MGI:5453015 snRNA gene predicted gene, 23238
19 gene 18.736739 18.749516 negative MGI_C57BL6J_5624699 Gm41814 NCBI_Gene:105246540 MGI:5624699 lncRNA gene predicted gene, 41814
19 gene 18.776746 18.776961 negative MGI_C57BL6J_5453967 Gm24190 ENSEMBL:ENSMUSG00000088601 MGI:5453967 unclassified non-coding RNA gene predicted gene, 24190
19 gene 18.930605 19.111196 negative MGI_C57BL6J_1343464 Rorb NCBI_Gene:225998,ENSEMBL:ENSMUSG00000036192 MGI:1343464 protein coding gene RAR-related orphan receptor beta
19 gene 19.244035 19.276348 negative MGI_C57BL6J_6303001 Gm50212 ENSEMBL:ENSMUSG00000117909 MGI:6303001 lncRNA gene predicted gene, 50212
19 gene 19.275899 19.276030 positive MGI_C57BL6J_5455214 Gm25437 ENSEMBL:ENSMUSG00000088907 MGI:5455214 snoRNA gene predicted gene, 25437
19 gene 19.276471 19.319651 positive MGI_C57BL6J_5624700 Gm41815 NCBI_Gene:105246541,ENSEMBL:ENSMUSG00000118109 MGI:5624700 lncRNA gene predicted gene, 41815
19 gene 19.821035 19.979149 positive MGI_C57BL6J_5591628 Gm32469 NCBI_Gene:102635029 MGI:5591628 lncRNA gene predicted gene, 32469
19 gene 19.871432 19.876563 negative MGI_C57BL6J_6303008 Gm50216 ENSEMBL:ENSMUSG00000118167 MGI:6303008 lncRNA gene predicted gene, 50216
19 gene 20.005940 20.060758 negative MGI_C57BL6J_3781903 Gm3728 NCBI_Gene:100042218,ENSEMBL:ENSMUSG00000118150 MGI:3781903 lncRNA gene predicted gene 3728
19 gene 20.033504 20.033635 negative MGI_C57BL6J_5452461 Gm22684 ENSEMBL:ENSMUSG00000064783 MGI:5452461 snoRNA gene predicted gene, 22684
19 gene 20.117385 20.283256 negative MGI_C57BL6J_5591788 Gm32629 NCBI_Gene:102635239,ENSEMBL:ENSMUSG00000118067 MGI:5591788 lncRNA gene predicted gene, 32629
19 gene 20.324856 20.444883 positive MGI_C57BL6J_1916244 1500015L24Rik NCBI_Gene:68994,ENSEMBL:ENSMUSG00000094732 MGI:1916244 lncRNA gene RIKEN cDNA 1500015L24 gene
19 gene 20.373428 20.390944 negative MGI_C57BL6J_96819 Anxa1 NCBI_Gene:16952,ENSEMBL:ENSMUSG00000024659 MGI:96819 protein coding gene annexin A1
19 gene 20.410544 20.552330 negative MGI_C57BL6J_2443493 C730002L08Rik NCBI_Gene:320155,ENSEMBL:ENSMUSG00000114469 MGI:2443493 lncRNA gene RIKEN cDNA C730002L08 gene
19 gene 20.424651 20.435261 negative MGI_C57BL6J_5591848 Gm32689 NCBI_Gene:102635317 MGI:5591848 lncRNA gene predicted gene, 32689
19 gene 20.437754 20.441386 positive MGI_C57BL6J_5624701 Gm41816 NCBI_Gene:105246542 MGI:5624701 lncRNA gene predicted gene, 41816
19 gene 20.492715 20.556410 positive MGI_C57BL6J_2443348 E030003E18Rik NCBI_Gene:320092 MGI:2443348 lncRNA gene RIKEN cDNA E030003E18 gene
19 gene 20.492715 20.643465 positive MGI_C57BL6J_1353450 Aldh1a1 NCBI_Gene:11668,ENSEMBL:ENSMUSG00000053279 MGI:1353450 protein coding gene aldehyde dehydrogenase family 1, subfamily A1
19 gene 20.583524 20.585067 positive MGI_C57BL6J_1917662 2900002J02Rik NA NA unclassified gene RIKEN cDNA 2900002J02 gene
19 pseudogene 20.585913 20.586826 negative MGI_C57BL6J_3643522 Gm6684 NCBI_Gene:626549,ENSEMBL:ENSMUSG00000047168 MGI:3643522 pseudogene predicted pseudogene 6684
19 gene 20.689467 20.690527 negative MGI_C57BL6J_3641948 C730037M02Rik NA NA unclassified gene RIKEN cDNA C730037M02 gene
19 gene 20.692953 20.727562 negative MGI_C57BL6J_1347050 Aldh1a7 NCBI_Gene:26358,ENSEMBL:ENSMUSG00000024747 MGI:1347050 protein coding gene aldehyde dehydrogenase family 1, subfamily A7
19 gene 20.783456 21.037147 negative MGI_C57BL6J_2151016 Tmc1 NCBI_Gene:13409,ENSEMBL:ENSMUSG00000024749 MGI:2151016 protein coding gene transmembrane channel-like gene family 1
19 gene 20.922392 20.954762 positive MGI_C57BL6J_5591909 Gm32750 NCBI_Gene:102635397,ENSEMBL:ENSMUSG00000118293 MGI:5591909 lncRNA gene predicted gene, 32750
19 gene 20.956541 20.961920 positive MGI_C57BL6J_5624702 Gm41817 NCBI_Gene:105246543 MGI:5624702 lncRNA gene predicted gene, 41817
19 gene 21.104502 21.107157 positive MGI_C57BL6J_1922604 4930554I06Rik NCBI_Gene:75354,ENSEMBL:ENSMUSG00000118047 MGI:1922604 lncRNA gene RIKEN cDNA 4930554I06 gene
19 gene 21.121191 21.125705 negative MGI_C57BL6J_3781949 Gm3775 NCBI_Gene:100042294 MGI:3781949 lncRNA gene predicted gene 3775
19 gene 21.138695 21.146597 positive MGI_C57BL6J_5592138 Gm32979 NCBI_Gene:102635711 MGI:5592138 lncRNA gene predicted gene, 32979
19 gene 21.165087 21.210686 negative MGI_C57BL6J_5825555 Gm45918 NCBI_Gene:105242408 MGI:5825555 lncRNA gene predicted gene, 45918
19 gene 21.208477 21.211973 positive MGI_C57BL6J_6303041 Gm50236 ENSEMBL:ENSMUSG00000118090 MGI:6303041 lncRNA gene predicted gene, 50236
19 pseudogene 21.261976 21.263212 negative MGI_C57BL6J_6303054 Gm50243 ENSEMBL:ENSMUSG00000118044 MGI:6303054 pseudogene predicted gene, 50243
19 gene 21.271891 21.286840 positive MGI_C57BL6J_1278334 Zfand5 NCBI_Gene:22682,ENSEMBL:ENSMUSG00000024750 MGI:1278334 protein coding gene zinc finger, AN1-type domain 5
19 gene 21.293946 21.295010 positive MGI_C57BL6J_1916228 1500002I01Rik NA NA unclassified gene RIKEN cDNA 1500002I01 gene
19 gene 21.310376 21.313283 negative MGI_C57BL6J_6303075 Gm50255 ENSEMBL:ENSMUSG00000118342 MGI:6303075 lncRNA gene predicted gene, 50255
19 gene 21.391307 21.473445 negative MGI_C57BL6J_95678 Gda NCBI_Gene:14544,ENSEMBL:ENSMUSG00000058624 MGI:95678 protein coding gene guanine deaminase
19 gene 21.487932 21.488152 positive MGI_C57BL6J_1917501 2010105D22Rik NA NA unclassified gene RIKEN cDNA 2010105D22 gene
19 gene 21.552204 21.557867 positive MGI_C57BL6J_3781620 Gm3443 ENSEMBL:ENSMUSG00000079382 MGI:3781620 protein coding gene predicted gene 3443
19 gene 21.577760 21.596179 negative MGI_C57BL6J_5621371 Gm38486 NCBI_Gene:102636055 MGI:5621371 lncRNA gene predicted gene, 38486
19 gene 21.581202 21.652976 negative MGI_C57BL6J_1913456 1110059E24Rik NCBI_Gene:66206,ENSEMBL:ENSMUSG00000035171 MGI:1913456 protein coding gene RIKEN cDNA 1110059E24 gene
19 gene 21.653185 21.685638 positive MGI_C57BL6J_1917816 Abhd17b NCBI_Gene:226016,ENSEMBL:ENSMUSG00000047368 MGI:1917816 protein coding gene abhydrolase domain containing 17B
19 gene 21.657796 21.661573 positive MGI_C57BL6J_1923222 5033423O07Rik NA NA unclassified gene RIKEN cDNA 5033423O07 gene
19 gene 21.663158 21.666018 positive MGI_C57BL6J_2445142 B230378D16Rik NA NA unclassified gene RIKEN cDNA B230378D16 gene
19 gene 21.689292 21.691115 positive MGI_C57BL6J_3028050 C130076G22Rik NA NA unclassified gene RIKEN cDNA C130076G22 gene
19 gene 21.713818 21.732331 positive MGI_C57BL6J_5624703 Gm41818 NCBI_Gene:105246544 MGI:5624703 lncRNA gene predicted gene, 41818
19 pseudogene 21.729270 21.729745 positive MGI_C57BL6J_6302871 Gm50129 ENSEMBL:ENSMUSG00000118055 MGI:6302871 pseudogene predicted gene, 50129
19 gene 21.777511 21.858360 positive MGI_C57BL6J_1890373 Cemip2 NCBI_Gene:83921,ENSEMBL:ENSMUSG00000024754 MGI:1890373 protein coding gene cell migration inducing hyaluronidase 2
19 gene 21.831451 21.833756 negative MGI_C57BL6J_6302872 Gm50130 ENSEMBL:ENSMUSG00000118021 MGI:6302872 lncRNA gene predicted gene, 50130
19 pseudogene 21.837571 21.838711 positive MGI_C57BL6J_5011136 Gm18951 NCBI_Gene:100418019 MGI:5011136 pseudogene predicted gene, 18951
19 pseudogene 21.937283 21.938567 positive MGI_C57BL6J_3645435 Gm5514 NCBI_Gene:433229,ENSEMBL:ENSMUSG00000045104 MGI:3645435 pseudogene predicted gene 5514
19 gene 21.941978 21.950889 negative MGI_C57BL6J_6302877 Gm50133 ENSEMBL:ENSMUSG00000118237 MGI:6302877 lncRNA gene predicted gene, 50133
19 gene 21.992573 22.021016 positive MGI_C57BL6J_5624704 Gm41819 ENSEMBL:ENSMUSG00000118273 MGI:5624704 lncRNA gene predicted gene, 41819
19 gene 21.997331 22.000152 positive MGI_C57BL6J_6302879 Gm50134 ENSEMBL:ENSMUSG00000118226 MGI:6302879 lncRNA gene predicted gene, 50134
19 gene 22.137798 22.995410 positive MGI_C57BL6J_2443101 Trpm3 NCBI_Gene:226025,ENSEMBL:ENSMUSG00000052387 MGI:2443101 protein coding gene transient receptor potential cation channel, subfamily M, member 3
19 gene 22.235521 22.235618 negative MGI_C57BL6J_5452283 Gm22506 ENSEMBL:ENSMUSG00000088558 MGI:5452283 snoRNA gene predicted gene, 22506
19 pseudogene 22.254745 22.262751 positive MGI_C57BL6J_5592914 Gm33755 NCBI_Gene:102636778 MGI:5592914 pseudogene predicted gene, 33755
19 gene 22.436276 22.455241 negative MGI_C57BL6J_5520994 Gm27151 NCBI_Gene:102641617,ENSEMBL:ENSMUSG00000098739 MGI:5520994 lncRNA gene predicted gene 27151
19 pseudogene 22.441007 22.443653 positive MGI_C57BL6J_3648670 Nsa2-ps1 NCBI_Gene:433230,ENSEMBL:ENSMUSG00000118353 MGI:3648670 pseudogene NSA2 ribosome biogenesis homolog, pseudogene 1
19 gene 22.509995 22.517465 positive MGI_C57BL6J_5592808 Gm33649 NCBI_Gene:102636640 MGI:5592808 lncRNA gene predicted gene, 33649
19 gene 22.552662 22.555198 positive MGI_C57BL6J_1925993 9630005C17Rik NA NA unclassified gene RIKEN cDNA 9630005C17 gene
19 gene 22.750605 22.750672 positive MGI_C57BL6J_2676879 Mir204 miRBase:MI0000247,NCBI_Gene:387200,ENSEMBL:ENSMUSG00000065507 MGI:2676879 miRNA gene microRNA 204
19 gene 22.776821 22.778324 positive MGI_C57BL6J_1920165 2900017F05Rik NA NA unclassified gene RIKEN cDNA 2900017F05 gene
19 gene 22.978230 23.075924 negative MGI_C57BL6J_1924860 C330002G04Rik NCBI_Gene:77610,ENSEMBL:ENSMUSG00000097930 MGI:1924860 lncRNA gene RIKEN cDNA C330002G04 gene
19 gene 23.061454 23.064032 positive MGI_C57BL6J_6302882 Gm50136 ENSEMBL:ENSMUSG00000118155 MGI:6302882 lncRNA gene predicted gene, 50136
19 gene 23.134498 23.137111 positive MGI_C57BL6J_1915498 2410080I02Rik NCBI_Gene:102636896,ENSEMBL:ENSMUSG00000044387 MGI:1915498 lncRNA gene RIKEN cDNA 2410080I02 gene
19 gene 23.141226 23.168134 positive MGI_C57BL6J_1333856 Klf9 NCBI_Gene:16601,ENSEMBL:ENSMUSG00000033863 MGI:1333856 protein coding gene Kruppel-like factor 9
19 gene 23.149431 23.149551 positive MGI_C57BL6J_3783365 Mir1192 miRBase:MI0006297,NCBI_Gene:100316672,ENSEMBL:ENSMUSG00000080626 MGI:3783365 miRNA gene microRNA 1192
19 gene 23.206441 23.273914 negative MGI_C57BL6J_2385088 Smc5 NCBI_Gene:226026,ENSEMBL:ENSMUSG00000024943 MGI:2385088 protein coding gene structural maintenance of chromosomes 5
19 gene 23.273925 23.274359 positive MGI_C57BL6J_5593109 Gm33950 NCBI_Gene:102637041 MGI:5593109 lncRNA gene predicted gene, 33950
19 gene 23.282096 23.309919 positive MGI_C57BL6J_5624706 Gm41821 NCBI_Gene:105246547,ENSEMBL:ENSMUSG00000117837 MGI:5624706 lncRNA gene predicted gene, 41821
19 gene 23.296329 23.296435 positive MGI_C57BL6J_5454040 Gm24263 ENSEMBL:ENSMUSG00000096249 MGI:5454040 snRNA gene predicted gene, 24263
19 gene 23.302609 23.448498 negative MGI_C57BL6J_1918988 Mamdc2 NCBI_Gene:71738,ENSEMBL:ENSMUSG00000033207 MGI:1918988 protein coding gene MAM domain containing 2
19 gene 23.418343 23.430928 positive MGI_C57BL6J_6303381 Gm50445 ENSEMBL:ENSMUSG00000118092 MGI:6303381 lncRNA gene predicted gene, 50445
19 pseudogene 23.437256 23.437727 negative MGI_C57BL6J_6303379 Gm50443 ENSEMBL:ENSMUSG00000117850 MGI:6303379 pseudogene predicted gene, 50443
19 gene 23.496764 23.523052 positive MGI_C57BL6J_5593171 Gm34012 NCBI_Gene:102637119 MGI:5593171 lncRNA gene predicted gene, 34012
19 gene 23.558753 23.652812 negative MGI_C57BL6J_1914733 1700028P14Rik NCBI_Gene:67483,ENSEMBL:ENSMUSG00000033053 MGI:1914733 protein coding gene RIKEN cDNA 1700028P14 gene
19 pseudogene 23.605898 23.606279 positive MGI_C57BL6J_6303347 Gm50422 ENSEMBL:ENSMUSG00000117944 MGI:6303347 pseudogene predicted gene, 50422
19 pseudogene 23.616904 23.620368 positive MGI_C57BL6J_3779903 Gm9493 NCBI_Gene:102638448,ENSEMBL:ENSMUSG00000044424 MGI:3779903 pseudogene predicted gene 9493
19 gene 23.643409 23.643510 positive MGI_C57BL6J_5451921 Gm22144 ENSEMBL:ENSMUSG00000088027 MGI:5451921 snoRNA gene predicted gene, 22144
19 pseudogene 23.666591 23.667583 positive MGI_C57BL6J_5434897 Gm21542 ENSEMBL:ENSMUSG00000098010 MGI:5434897 pseudogene predicted gene, 21542
19 pseudogene 23.675811 23.676735 positive MGI_C57BL6J_3646907 Gm6563 NCBI_Gene:625193,ENSEMBL:ENSMUSG00000051255 MGI:3646907 pseudogene predicted pseudogene 6563
19 gene 23.686898 23.732885 positive MGI_C57BL6J_1921875 Ptar1 NCBI_Gene:72351,ENSEMBL:ENSMUSG00000074925 MGI:1921875 protein coding gene protein prenyltransferase alpha subunit repeat containing 1
19 gene 23.723279 23.725034 positive MGI_C57BL6J_3641836 Gm9938 NA NA protein coding gene predicted gene 9938
19 gene 23.728707 23.731661 positive MGI_C57BL6J_1920060 2810455D13Rik NA NA unclassified gene RIKEN cDNA 2810455D13 gene
19 gene 23.745502 23.748001 negative MGI_C57BL6J_6303146 Gm50299 ENSEMBL:ENSMUSG00000117685 MGI:6303146 lncRNA gene predicted gene, 50299
19 gene 23.758806 23.949598 positive MGI_C57BL6J_1860297 Apba1 NCBI_Gene:319924,ENSEMBL:ENSMUSG00000024897 MGI:1860297 protein coding gene amyloid beta (A4) precursor protein binding, family A, member 1
19 pseudogene 23.800538 23.800817 positive MGI_C57BL6J_6303148 Gm50300 ENSEMBL:ENSMUSG00000118287 MGI:6303148 pseudogene predicted gene, 50300
19 gene 23.870740 23.871826 positive MGI_C57BL6J_1925097 B230104F01Rik NA NA unclassified gene RIKEN cDNA B230104F01 gene
19 gene 23.905122 23.917546 negative MGI_C57BL6J_5593235 Gm34076 NCBI_Gene:102637203 MGI:5593235 lncRNA gene predicted gene, 34076
19 gene 23.929825 23.941594 negative MGI_C57BL6J_6303149 Gm50301 ENSEMBL:ENSMUSG00000118340 MGI:6303149 lncRNA gene predicted gene, 50301
19 gene 23.972750 24.031272 negative MGI_C57BL6J_2685813 Fam189a2 NCBI_Gene:381217,ENSEMBL:ENSMUSG00000071604 MGI:2685813 protein coding gene family with sequence similarity 189, member A2
19 pseudogene 24.004780 24.005008 positive MGI_C57BL6J_6303156 Gm50305 ENSEMBL:ENSMUSG00000117820 MGI:6303156 pseudogene predicted gene, 50305
19 gene 24.044383 24.047157 negative MGI_C57BL6J_5624708 Gm41823 NCBI_Gene:105246549 MGI:5624708 lncRNA gene predicted gene, 41823
19 gene 24.064793 24.066452 positive MGI_C57BL6J_1922771 1700021P04Rik ENSEMBL:ENSMUSG00000096796 MGI:1922771 lncRNA gene RIKEN cDNA 1700021P04 gene
19 gene 24.080931 24.090765 positive MGI_C57BL6J_5624709 Gm41824 NCBI_Gene:105246550 MGI:5624709 lncRNA gene predicted gene, 41824
19 gene 24.094502 24.225130 negative MGI_C57BL6J_1341872 Tjp2 NCBI_Gene:21873,ENSEMBL:ENSMUSG00000024812 MGI:1341872 protein coding gene tight junction protein 2
19 pseudogene 24.146897 24.147224 negative MGI_C57BL6J_6303163 Gm50310 ENSEMBL:ENSMUSG00000118277 MGI:6303163 pseudogene predicted gene, 50310
19 pseudogene 24.154070 24.154601 positive MGI_C57BL6J_6303160 Gm50308 ENSEMBL:ENSMUSG00000118371 MGI:6303160 pseudogene predicted gene, 50308
19 gene 24.261453 24.280605 negative MGI_C57BL6J_1096879 Fxn NCBI_Gene:14297,ENSEMBL:ENSMUSG00000059363 MGI:1096879 protein coding gene frataxin
19 pseudogene 24.289000 24.290908 negative MGI_C57BL6J_3646651 Gm8789 NCBI_Gene:667743 MGI:3646651 pseudogene predicted gene 8789
19 pseudogene 24.289716 24.290826 positive MGI_C57BL6J_3801728 Gm16216 ENSEMBL:ENSMUSG00000082107 MGI:3801728 pseudogene predicted gene 16216
19 gene 24.294794 24.555872 negative MGI_C57BL6J_107930 Pip5k1b NCBI_Gene:18719,ENSEMBL:ENSMUSG00000024867 MGI:107930 protein coding gene phosphatidylinositol-4-phosphate 5-kinase, type 1 beta
19 gene 24.298838 24.300938 negative MGI_C57BL6J_3782025 Gm3853 NA NA unclassified gene predicted gene 3853
19 gene 24.413789 24.430694 positive MGI_C57BL6J_1922106 Pip5k1bos NCBI_Gene:102637283,ENSEMBL:ENSMUSG00000085003 MGI:1922106 antisense lncRNA gene phosphatidylinositol-4-phosphate 5-kinase, type 1 beta, opposite strand
19 gene 24.475779 24.477474 negative MGI_C57BL6J_1915284 Fam122a NCBI_Gene:68034,ENSEMBL:ENSMUSG00000074922 MGI:1915284 protein coding gene family with sequence similarity 122, member A
19 gene 24.541198 24.541455 negative MGI_C57BL6J_3641847 E860004J03Rik NA NA unclassified non-coding RNA gene RIKEN cDNA E860004J03 gene
19 gene 24.556352 24.557228 positive MGI_C57BL6J_6303218 Gm50341 ENSEMBL:ENSMUSG00000117979 MGI:6303218 lncRNA gene predicted gene, 50341
19 gene 24.674008 24.682233 positive MGI_C57BL6J_3583948 Tmem252 NCBI_Gene:226040,ENSEMBL:ENSMUSG00000048572 MGI:3583948 protein coding gene transmembrane protein 252
19 gene 24.678261 24.861855 negative MGI_C57BL6J_1925668 Pgm5 NCBI_Gene:226041,ENSEMBL:ENSMUSG00000041731 MGI:1925668 protein coding gene phosphoglucomutase 5
19 pseudogene 24.692233 24.693391 negative MGI_C57BL6J_5009986 Gm17800 NCBI_Gene:100158260,ENSEMBL:ENSMUSG00000097950 MGI:5009986 pseudogene predicted gene, 17800
19 gene 24.706836 24.713712 positive MGI_C57BL6J_5621466 Gm38581 NCBI_Gene:102641855 MGI:5621466 lncRNA gene predicted gene, 38581
19 pseudogene 24.856196 24.856457 positive MGI_C57BL6J_6303220 Gm50342 ENSEMBL:ENSMUSG00000117934 MGI:6303220 pseudogene predicted gene, 50342
19 pseudogene 24.875686 24.876875 positive MGI_C57BL6J_3704493 Gm10053 NCBI_Gene:672195,ENSEMBL:ENSMUSG00000058927 MGI:3704493 pseudogene predicted gene 10053
19 gene 24.898965 24.901309 negative MGI_C57BL6J_1347467 Foxd4 NCBI_Gene:14237,ENSEMBL:ENSMUSG00000051490 MGI:1347467 protein coding gene forkhead box D4
19 gene 24.919916 24.961616 negative MGI_C57BL6J_2385089 Cbwd1 NCBI_Gene:226043,ENSEMBL:ENSMUSG00000024878 MGI:2385089 protein coding gene COBW domain containing 1
19 gene 24.942235 24.942303 negative MGI_C57BL6J_5562753 Mir3084-1 miRBase:MI0014047,NCBI_Gene:100526521,ENSEMBL:ENSMUSG00000104890 MGI:5562753 miRNA gene microRNA 3084-1
19 gene 24.942236 24.942367 negative MGI_C57BL6J_5453435 Gm23658 ENSEMBL:ENSMUSG00000095097 MGI:5453435 snoRNA gene predicted gene, 23658
19 gene 24.999511 25.202432 positive MGI_C57BL6J_1921396 Dock8 NCBI_Gene:76088,ENSEMBL:ENSMUSG00000052085 MGI:1921396 protein coding gene dedicator of cytokinesis 8
19 gene 25.033108 25.033578 positive MGI_C57BL6J_3782046 Ndufb4b NCBI_Gene:100042503 MGI:3782046 protein coding gene NADH:ubiquinone oxidoreductase subunit B4B
19 gene 25.092866 25.097404 negative MGI_C57BL6J_5593394 Gm34235 NCBI_Gene:102637425 MGI:5593394 lncRNA gene predicted gene, 34235
19 gene 25.153231 25.155877 negative MGI_C57BL6J_5593345 Gm34186 NCBI_Gene:102637351 MGI:5593345 lncRNA gene predicted gene, 34186
19 gene 25.166085 25.166216 negative MGI_C57BL6J_5454029 Gm24252 ENSEMBL:ENSMUSG00000065634 MGI:5454029 snoRNA gene predicted gene, 24252
19 gene 25.236732 25.434497 positive MGI_C57BL6J_2147707 Kank1 NCBI_Gene:107351,ENSEMBL:ENSMUSG00000032702 MGI:2147707 protein coding gene KN motif and ankyrin repeat domains 1
19 pseudogene 25.346409 25.347243 negative MGI_C57BL6J_5593591 Gm34432 NCBI_Gene:102637686,ENSEMBL:ENSMUSG00000118238 MGI:5593591 pseudogene predicted gene, 34432
19 gene 25.453960 25.454063 negative MGI_C57BL6J_5455984 Gm26207 ENSEMBL:ENSMUSG00000064843 MGI:5455984 snRNA gene predicted gene, 26207
19 pseudogene 25.493833 25.496716 positive MGI_C57BL6J_3646471 Gm5249 NCBI_Gene:383474,ENSEMBL:ENSMUSG00000117720 MGI:3646471 pseudogene predicted gene 5249
19 gene 25.505618 25.604329 positive MGI_C57BL6J_1354733 Dmrt1 NCBI_Gene:50796,ENSEMBL:ENSMUSG00000024837 MGI:1354733 protein coding gene doublesex and mab-3 related transcription factor 1
19 gene 25.610246 25.623921 positive MGI_C57BL6J_2449470 Dmrt3 NCBI_Gene:240590,ENSEMBL:ENSMUSG00000042372 MGI:2449470 protein coding gene doublesex and mab-3 related transcription factor 3
19 gene 25.671134 25.672253 negative MGI_C57BL6J_1919653 2610016A17Rik NCBI_Gene:100503074,ENSEMBL:ENSMUSG00000101089 MGI:1919653 lncRNA gene RIKEN cDNA 2610016A17 gene
19 gene 25.672389 25.679013 positive MGI_C57BL6J_1330307 Dmrt2 NCBI_Gene:226049,ENSEMBL:ENSMUSG00000048138 MGI:1330307 protein coding gene doublesex and mab-3 related transcription factor 2
19 gene 25.775487 25.946975 positive MGI_C57BL6J_5593675 Gm34516 NCBI_Gene:102637794 MGI:5593675 lncRNA gene predicted gene, 34516
19 pseudogene 25.795612 25.796825 negative MGI_C57BL6J_3647098 Gm8825 NCBI_Gene:667806,ENSEMBL:ENSMUSG00000098105 MGI:3647098 pseudogene predicted gene 8825
19 gene 26.030730 26.046626 negative MGI_C57BL6J_1920683 1700048O14Rik NCBI_Gene:73433,ENSEMBL:ENSMUSG00000118016 MGI:1920683 lncRNA gene RIKEN cDNA 1700048O14 gene
19 gene 26.246024 26.249930 negative MGI_C57BL6J_6303272 Gm50376 ENSEMBL:ENSMUSG00000117950 MGI:6303272 lncRNA gene predicted gene, 50376
19 gene 26.260369 26.260493 negative MGI_C57BL6J_5454953 Gm25176 ENSEMBL:ENSMUSG00000084589 MGI:5454953 snRNA gene predicted gene, 25176
19 gene 26.277846 26.308707 negative MGI_C57BL6J_6303274 Gm50377 ENSEMBL:ENSMUSG00000118005 MGI:6303274 lncRNA gene predicted gene, 50377
19 gene 26.462344 26.467779 negative MGI_C57BL6J_6303276 Gm50378 ENSEMBL:ENSMUSG00000117707 MGI:6303276 lncRNA gene predicted gene, 50378
19 gene 26.482315 26.509084 negative MGI_C57BL6J_5593967 Gm34808 NCBI_Gene:102638185,ENSEMBL:ENSMUSG00000118001 MGI:5593967 lncRNA gene predicted gene, 34808
19 gene 26.510339 26.527796 positive MGI_C57BL6J_5624713 Gm41828 NCBI_Gene:105246554 MGI:5624713 lncRNA gene predicted gene, 41828
19 pseudogene 26.530752 26.530929 positive MGI_C57BL6J_6303278 Gm50379 ENSEMBL:ENSMUSG00000117803 MGI:6303278 pseudogene predicted gene, 50379
19 gene 26.572996 26.584672 positive MGI_C57BL6J_6098469 Gm48775 ENSEMBL:ENSMUSG00000114682 MGI:6098469 lncRNA gene predicted gene, 48775
19 gene 26.605050 26.778322 positive MGI_C57BL6J_99603 Smarca2 NCBI_Gene:67155,ENSEMBL:ENSMUSG00000024921 MGI:99603 protein coding gene SWI/SNF related, matrix associated, actin dependent regulator of chromatin, subfamily a, member 2
19 gene 26.620749 26.623419 negative MGI_C57BL6J_5313063 Gm20616 NCBI_Gene:102638259,ENSEMBL:ENSMUSG00000093628 MGI:5313063 lncRNA gene predicted gene 20616
19 gene 26.768801 26.823907 negative MGI_C57BL6J_1918192 4931403E22Rik NCBI_Gene:70942,ENSEMBL:ENSMUSG00000093772 MGI:1918192 lncRNA gene RIKEN cDNA 4931403E22 gene
19 pseudogene 26.802040 26.803219 positive MGI_C57BL6J_5010565 Gm18380 NCBI_Gene:100417041,ENSEMBL:ENSMUSG00000118331 MGI:5010565 pseudogene predicted gene, 18380
19 gene 26.823866 26.872509 positive MGI_C57BL6J_5826285 Gm46648 NCBI_Gene:108168409 MGI:5826285 lncRNA gene predicted gene, 46648
19 gene 26.885881 26.888647 positive MGI_C57BL6J_2685661 Gm815 NCBI_Gene:329047,ENSEMBL:ENSMUSG00000074913 MGI:2685661 protein coding gene predicted gene 815
19 pseudogene 27.025981 27.026314 positive MGI_C57BL6J_6302862 Gm50121 ENSEMBL:ENSMUSG00000118313 MGI:6302862 pseudogene predicted gene, 50121
19 gene 27.101951 27.316698 negative MGI_C57BL6J_5594597 Gm35438 NCBI_Gene:102639019,ENSEMBL:ENSMUSG00000118020,ENSEMBL:ENSMUSG00000118209 MGI:5594597 lncRNA gene predicted gene, 35438
19 gene 27.216484 27.254231 positive MGI_C57BL6J_98935 Vldlr NCBI_Gene:22359,ENSEMBL:ENSMUSG00000024924 MGI:98935 protein coding gene very low density lipoprotein receptor
19 gene 27.260735 27.262323 negative MGI_C57BL6J_3782090 Gm3916 NA NA unclassified gene predicted gene 3916
19 gene 27.260735 27.262323 negative MGI_C57BL6J_6302852 Gm50114 ENSEMBL:ENSMUSG00000117692 MGI:6302852 lncRNA gene predicted gene, 50114
19 gene 27.312632 27.321729 positive MGI_C57BL6J_5594427 Gm35268 NCBI_Gene:102638787 MGI:5594427 lncRNA gene predicted gene, 35268
19 gene 27.322061 27.337179 positive MGI_C57BL6J_2670981 Kcnv2 NCBI_Gene:240595,ENSEMBL:ENSMUSG00000047298 MGI:2670981 protein coding gene potassium channel, subfamily V, member 2
19 gene 27.344725 27.373932 positive MGI_C57BL6J_5594713 Gm35554 NCBI_Gene:102639185,ENSEMBL:ENSMUSG00000117752 MGI:5594713 lncRNA gene predicted gene, 35554
19 pseudogene 27.366072 27.366567 positive MGI_C57BL6J_6302851 Gm50113 ENSEMBL:ENSMUSG00000117705 MGI:6302851 pseudogene predicted gene, 50113
19 gene 27.388698 27.429908 negative MGI_C57BL6J_106253 Pum3 NCBI_Gene:52874,ENSEMBL:ENSMUSG00000041360 MGI:106253 protein coding gene pumilio RNA-binding family member 3
19 gene 27.430037 27.432631 positive MGI_C57BL6J_2147728 C030016D13Rik NCBI_Gene:107372 MGI:2147728 lncRNA gene RIKEN cDNA C030016D13 gene
19 pseudogene 27.512508 27.513279 positive MGI_C57BL6J_6302831 Gm50101 ENSEMBL:ENSMUSG00000118072 MGI:6302831 pseudogene predicted gene, 50101
19 gene 27.666428 27.668494 negative MGI_C57BL6J_5594856 Gm35697 NCBI_Gene:102639367 MGI:5594856 lncRNA gene predicted gene, 35697
19 gene 27.703876 27.704007 negative MGI_C57BL6J_5454559 Gm24782 ENSEMBL:ENSMUSG00000088266 MGI:5454559 snoRNA gene predicted gene, 24782
19 gene 27.761721 28.011693 negative MGI_C57BL6J_106582 Rfx3 NCBI_Gene:19726,ENSEMBL:ENSMUSG00000040929 MGI:106582 protein coding gene regulatory factor X, 3 (influences HLA class II expression)
19 pseudogene 27.858058 27.858497 positive MGI_C57BL6J_3647318 Gm8412 ENSEMBL:ENSMUSG00000092617 MGI:3647318 pseudogene predicted gene 8412
19 pseudogene 27.961274 27.962110 positive MGI_C57BL6J_5010079 Gm17894 NCBI_Gene:100416057 MGI:5010079 pseudogene predicted gene, 17894
19 gene 27.994197 27.995693 positive MGI_C57BL6J_5141872 Gm20407 ENSEMBL:ENSMUSG00000092182 MGI:5141872 lncRNA gene predicted gene 20407
19 pseudogene 28.033455 28.034153 positive MGI_C57BL6J_3648671 Gm5517 NCBI_Gene:433235,ENSEMBL:ENSMUSG00000117788 MGI:3648671 pseudogene predicted gene 5517
19 gene 28.088856 28.089764 positive MGI_C57BL6J_5578934 Gm28228 ENSEMBL:ENSMUSG00000101084 MGI:5578934 lncRNA gene predicted gene 28228
19 pseudogene 28.145864 28.146319 negative MGI_C57BL6J_5594940 Gm35781 NCBI_Gene:102639477,ENSEMBL:ENSMUSG00000117862 MGI:5594940 pseudogene predicted gene, 35781
19 gene 28.258851 28.680265 negative MGI_C57BL6J_2444289 Glis3 NCBI_Gene:226075,ENSEMBL:ENSMUSG00000052942 MGI:2444289 protein coding gene GLIS family zinc finger 3
19 gene 28.362542 28.365815 negative MGI_C57BL6J_5595025 Gm35866 NCBI_Gene:102639589 MGI:5595025 lncRNA gene predicted gene, 35866
19 gene 28.580533 28.583294 negative MGI_C57BL6J_1921702 4933413C19Rik ENSEMBL:ENSMUSG00000089952 MGI:1921702 lncRNA gene RIKEN cDNA 4933413C19 gene
19 gene 28.678224 28.720027 positive MGI_C57BL6J_2443529 D930032P07Rik NCBI_Gene:320176,ENSEMBL:ENSMUSG00000097735 MGI:2443529 lncRNA gene RIKEN cDNA D930032P07 gene
19 pseudogene 28.742123 28.742568 negative MGI_C57BL6J_3643316 Rps15a-ps2 NCBI_Gene:434460,ENSEMBL:ENSMUSG00000067351 MGI:3643316 pseudogene ribosomal protein S15A, pseudogene 2
19 gene 28.760033 28.788185 positive MGI_C57BL6J_5595081 Gm35922 NCBI_Gene:102639664 MGI:5595081 lncRNA gene predicted gene, 35922
19 pseudogene 28.762865 28.763539 negative MGI_C57BL6J_3646480 Gm6788 NCBI_Gene:627788,ENSEMBL:ENSMUSG00000090737 MGI:3646480 pseudogene predicted gene 6788
19 pseudogene 28.812406 28.813202 negative MGI_C57BL6J_5504057 Gm26942 ENSEMBL:ENSMUSG00000098069 MGI:5504057 pseudogene predicted gene, 26942
19 gene 28.835049 28.913960 positive MGI_C57BL6J_105083 Slc1a1 NCBI_Gene:20510,ENSEMBL:ENSMUSG00000024935 MGI:105083 protein coding gene solute carrier family 1 (neuronal/epithelial high affinity glutamate transporter, system Xag), member 1
19 pseudogene 28.862012 28.863766 negative MGI_C57BL6J_3648836 Gm5822 NCBI_Gene:545262,ENSEMBL:ENSMUSG00000089993 MGI:3648836 pseudogene predicted gene 5822
19 gene 28.893042 28.968356 negative MGI_C57BL6J_1918036 4430402I18Rik NCBI_Gene:381218,ENSEMBL:ENSMUSG00000064202 MGI:1918036 protein coding gene RIKEN cDNA 4430402I18 gene
19 gene 28.963920 28.966811 positive MGI_C57BL6J_1921661 Plpp6 NCBI_Gene:74411,ENSEMBL:ENSMUSG00000040105 MGI:1921661 protein coding gene phospholipid phosphatase 6
19 pseudogene 28.973039 28.974077 positive MGI_C57BL6J_3781797 Gm3621 NCBI_Gene:100042006,ENSEMBL:ENSMUSG00000118165 MGI:3781797 pseudogene predicted gene 3621
19 pseudogene 28.974550 28.975633 negative MGI_C57BL6J_3643046 Gm4844 NCBI_Gene:226086 MGI:3643046 pseudogene predicted gene 4844
19 gene 28.990318 29.026681 positive MGI_C57BL6J_1914322 Cdc37l1 NCBI_Gene:67072,ENSEMBL:ENSMUSG00000024780 MGI:1914322 protein coding gene cell division cycle 37-like 1
19 gene 28.995379 29.048091 negative MGI_C57BL6J_1860835 Ak3 NCBI_Gene:56248,ENSEMBL:ENSMUSG00000024782 MGI:1860835 protein coding gene adenylate kinase 3
19 pseudogene 29.003343 29.003875 negative MGI_C57BL6J_3704242 Gm10136 NCBI_Gene:672214,ENSEMBL:ENSMUSG00000063754 MGI:3704242 pseudogene predicted pseudogene 10136
19 gene 29.046245 29.048729 positive MGI_C57BL6J_1914579 1700018L02Rik NCBI_Gene:67329,ENSEMBL:ENSMUSG00000100075 MGI:1914579 lncRNA gene RIKEN cDNA 1700018L02 gene
19 gene 29.067301 29.069503 positive MGI_C57BL6J_3642802 Gm9895 NCBI_Gene:100503337,ENSEMBL:ENSMUSG00000118038 MGI:3642802 lncRNA gene predicted gene 9895
19 pseudogene 29.087603 29.090255 negative MGI_C57BL6J_6303352 Gm50425 ENSEMBL:ENSMUSG00000118320 MGI:6303352 pseudogene predicted gene, 50425
19 gene 29.101375 29.143929 positive MGI_C57BL6J_1913275 Rcl1 NCBI_Gene:59028,ENSEMBL:ENSMUSG00000024785 MGI:1913275 protein coding gene RNA terminal phosphate cyclase-like 1
19 gene 29.135279 29.135375 positive MGI_C57BL6J_3618696 Mir101b miRBase:MI0000649,NCBI_Gene:724062,ENSEMBL:ENSMUSG00000065556 MGI:3618696 miRNA gene microRNA 101b
19 gene 29.147630 29.149431 positive MGI_C57BL6J_3642922 Gm9883 NA NA unclassified gene predicted gene 9883
19 pseudogene 29.160000 29.161262 positive MGI_C57BL6J_3648673 Gm5518 NCBI_Gene:433238,ENSEMBL:ENSMUSG00000068466 MGI:3648673 pseudogene predicted gene 5518
19 gene 29.238057 29.242703 negative MGI_C57BL6J_5624714 Gm41829 NCBI_Gene:105246555 MGI:5624714 lncRNA gene predicted gene, 41829
19 gene 29.251708 29.313080 positive MGI_C57BL6J_96629 Jak2 NCBI_Gene:16452,ENSEMBL:ENSMUSG00000024789 MGI:96629 protein coding gene Janus kinase 2
19 gene 29.321344 29.325356 negative MGI_C57BL6J_1351595 Insl6 NCBI_Gene:27356,ENSEMBL:ENSMUSG00000050957 MGI:1351595 protein coding gene insulin-like 6
19 gene 29.331170 29.334670 negative MGI_C57BL6J_97931 Rln1 NCBI_Gene:19773,ENSEMBL:ENSMUSG00000039097 MGI:97931 protein coding gene relaxin 1
19 gene 29.348599 29.367390 negative MGI_C57BL6J_1915009 Plgrkt NCBI_Gene:67759,ENSEMBL:ENSMUSG00000016495 MGI:1915009 protein coding gene plasminogen receptor, C-terminal lysine transmembrane protein
19 gene 29.367438 29.388095 positive MGI_C57BL6J_1926446 Cd274 NCBI_Gene:60533,ENSEMBL:ENSMUSG00000016496 MGI:1926446 protein coding gene CD274 antigen
19 gene 29.373417 29.385383 negative MGI_C57BL6J_5595202 Gm36043 NCBI_Gene:102639821,ENSEMBL:ENSMUSG00000117964 MGI:5595202 lncRNA gene predicted gene, 36043
19 gene 29.410919 29.472927 positive MGI_C57BL6J_1930125 Pdcd1lg2 NCBI_Gene:58205,ENSEMBL:ENSMUSG00000016498 MGI:1930125 protein coding gene programmed cell death 1 ligand 2
19 gene 29.464750 29.523159 negative MGI_C57BL6J_1925029 A930007I19Rik NCBI_Gene:77779,ENSEMBL:ENSMUSG00000097855 MGI:1925029 lncRNA gene RIKEN cDNA A930007I19 gene
19 gene 29.522282 29.606829 positive MGI_C57BL6J_1924893 Ric1 NCBI_Gene:226089,ENSEMBL:ENSMUSG00000038658 MGI:1924893 protein coding gene RAB6A GEF complex partner 1
19 gene 29.608214 29.648510 negative MGI_C57BL6J_106250 Ermp1 NCBI_Gene:226090,ENSEMBL:ENSMUSG00000046324 MGI:106250 protein coding gene endoplasmic reticulum metallopeptidase 1
19 gene 29.682177 29.684238 negative MGI_C57BL6J_5595285 Gm36126 NCBI_Gene:102639928 MGI:5595285 lncRNA gene predicted gene, 36126
19 gene 29.697541 29.708634 positive MGI_C57BL6J_108454 Mlana NCBI_Gene:77836,ENSEMBL:ENSMUSG00000024806 MGI:108454 protein coding gene melan-A
19 gene 29.714402 29.808053 negative MGI_C57BL6J_2444398 9930021J03Rik NCBI_Gene:240613,ENSEMBL:ENSMUSG00000046138 MGI:2444398 protein coding gene RIKEN cDNA 9930021J03 gene
19 gene 29.806663 29.810096 positive MGI_C57BL6J_6303267 Gm50373 ENSEMBL:ENSMUSG00000118251 MGI:6303267 lncRNA gene predicted gene, 50373
19 gene 29.808108 29.812974 negative MGI_C57BL6J_2683212 Ranbp6 NCBI_Gene:240614,ENSEMBL:ENSMUSG00000074909 MGI:2683212 protein coding gene RAN binding protein 6
19 gene 29.838453 29.927333 negative MGI_C57BL6J_5624717 Gm41832 NCBI_Gene:105246558 MGI:5624717 lncRNA gene predicted gene, 41832
19 pseudogene 29.874191 29.875217 negative MGI_C57BL6J_6303279 Gm50380 ENSEMBL:ENSMUSG00000117883 MGI:6303279 pseudogene predicted gene, 50380
19 gene 29.877449 29.884689 positive MGI_C57BL6J_5595368 Gm36209 NCBI_Gene:102640041 MGI:5595368 lncRNA gene predicted gene, 36209
19 gene 29.893703 29.896235 positive MGI_C57BL6J_5624716 Gm41831 NCBI_Gene:105246557 MGI:5624716 lncRNA gene predicted gene, 41831
19 gene 29.925114 29.960718 positive MGI_C57BL6J_1924375 Il33 NCBI_Gene:77125,ENSEMBL:ENSMUSG00000024810 MGI:1924375 protein coding gene interleukin 33
19 gene 29.986099 29.986264 positive MGI_C57BL6J_5455823 Gm26046 ENSEMBL:ENSMUSG00000087937 MGI:5455823 snRNA gene predicted gene, 26046
19 gene 30.003790 30.006020 positive MGI_C57BL6J_1913995 Trpd52l3 NCBI_Gene:66745,ENSEMBL:ENSMUSG00000024815 MGI:1913995 protein coding gene tumor protein D52-like 3
19 gene 30.030435 30.093726 positive MGI_C57BL6J_1923718 Uhrf2 NCBI_Gene:109113,ENSEMBL:ENSMUSG00000024817 MGI:1923718 protein coding gene ubiquitin-like, containing PHD and RING finger domains 2
19 gene 30.098441 30.175441 negative MGI_C57BL6J_1341155 Gldc NCBI_Gene:104174,ENSEMBL:ENSMUSG00000024827 MGI:1341155 protein coding gene glycine decarboxylase
19 pseudogene 30.160620 30.161030 positive MGI_C57BL6J_3644512 Rpl31-ps20 NCBI_Gene:625917,ENSEMBL:ENSMUSG00000058607 MGI:3644512 pseudogene ribosomal protein L31, pseudogene 20
19 gene 30.164751 30.165769 negative MGI_C57BL6J_1924689 9530025L08Rik NA NA unclassified gene RIKEN cDNA 9530025L08 gene
19 gene 30.232906 30.239687 positive MGI_C57BL6J_96924 Mbl2 NCBI_Gene:17195,ENSEMBL:ENSMUSG00000024863 MGI:96924 protein coding gene mannose-binding lectin (protein C) 2
19 gene 30.261441 30.261517 negative MGI_C57BL6J_5453885 Gm24108 ENSEMBL:ENSMUSG00000093236 MGI:5453885 miRNA gene predicted gene, 24108
19 gene 30.264880 30.265160 positive MGI_C57BL6J_5454660 Gm24883 ENSEMBL:ENSMUSG00000089016 MGI:5454660 unclassified non-coding RNA gene predicted gene, 24883
19 pseudogene 30.352005 30.355618 negative MGI_C57BL6J_5595165 Gm36006 NCBI_Gene:102639775 MGI:5595165 pseudogene predicted gene, 36006
19 gene 30.358217 30.360680 negative MGI_C57BL6J_1920607 1700048J15Rik NA NA unclassified gene RIKEN cDNA 1700048J15 gene
19 gene 30.371465 30.395327 negative MGI_C57BL6J_5595478 Gm36319 NCBI_Gene:102640191 MGI:5595478 lncRNA gene predicted gene, 36319
19 pseudogene 30.490703 30.491363 negative MGI_C57BL6J_5010070 Gm17885 NCBI_Gene:100416039,ENSEMBL:ENSMUSG00000118374 MGI:5010070 pseudogene predicted gene, 17885
19 pseudogene 30.531476 30.531929 negative MGI_C57BL6J_6303088 Gm50264 ENSEMBL:ENSMUSG00000117953 MGI:6303088 pseudogene predicted gene, 50264
19 pseudogene 30.538876 30.539679 negative MGI_C57BL6J_3645534 Ppp1r2-ps3 NCBI_Gene:546723,ENSEMBL:ENSMUSG00000058816 MGI:3645534 pseudogene protein phosphatase 1, regulatory (inhibitor) subunit 2, pseudogene 3
19 gene 30.545863 30.549665 negative MGI_C57BL6J_1329040 Dkk1 NCBI_Gene:13380,ENSEMBL:ENSMUSG00000024868 MGI:1329040 protein coding gene dickkopf WNT signaling pathway inhibitor 1
19 gene 30.564487 31.765309 negative MGI_C57BL6J_108174 Prkg1 NCBI_Gene:19091,ENSEMBL:ENSMUSG00000052920 MGI:108174 protein coding gene protein kinase, cGMP-dependent, type I
19 gene 30.704081 30.704398 positive MGI_C57BL6J_5453203 Gm23426 ENSEMBL:ENSMUSG00000084432 MGI:5453203 unclassified non-coding RNA gene predicted gene, 23426
19 pseudogene 30.878834 30.879352 positive MGI_C57BL6J_5011208 Gm19023 NCBI_Gene:100418132 MGI:5011208 pseudogene predicted gene, 19023
19 pseudogene 30.930380 30.930962 negative MGI_C57BL6J_3648551 Gm6642 NCBI_Gene:625995 MGI:3648551 pseudogene predicted gene 6642
19 gene 31.082837 31.087069 positive MGI_C57BL6J_1932622 Cstf2t NCBI_Gene:83410,ENSEMBL:ENSMUSG00000053536 MGI:1932622 protein coding gene cleavage stimulation factor, 3’ pre-RNA subunit 2, tau
19 pseudogene 31.112546 31.113095 positive MGI_C57BL6J_6303091 Gm50266 ENSEMBL:ENSMUSG00000118011 MGI:6303091 pseudogene predicted gene, 50266
19 gene 31.127685 31.137532 positive MGI_C57BL6J_5624719 Gm41834 NCBI_Gene:105246560 MGI:5624719 lncRNA gene predicted gene, 41834
19 gene 31.196484 31.197357 negative MGI_C57BL6J_1920156 2900042A17Rik NA NA unclassified gene RIKEN cDNA 2900042A17 gene
19 gene 31.213543 31.216396 negative MGI_C57BL6J_1925353 8430431K14Rik NCBI_Gene:78103 MGI:1925353 lncRNA gene RIKEN cDNA 8430431K14 gene
19 gene 31.505322 31.507369 negative MGI_C57BL6J_1921789 9030425L15Rik NA NA unclassified gene RIKEN cDNA 9030425L15 gene
19 gene 31.542570 31.550540 negative MGI_C57BL6J_2442795 9330185G11Rik NA NA unclassified gene RIKEN cDNA 9330185G11 gene
19 gene 31.868755 31.952365 positive MGI_C57BL6J_1917115 A1cf NCBI_Gene:69865,ENSEMBL:ENSMUSG00000052595 MGI:1917115 protein coding gene APOBEC1 complementation factor
19 pseudogene 31.913644 31.914916 positive MGI_C57BL6J_5011426 Gm19241 NCBI_Gene:100418483,ENSEMBL:ENSMUSG00000114443 MGI:5011426 pseudogene predicted gene, 19241
19 gene 31.950084 31.952361 positive MGI_C57BL6J_1918870 9130016M20Rik ENSEMBL:ENSMUSG00000118366 MGI:1918870 lncRNA gene RIKEN cDNA 9130016M20 gene
19 gene 31.982597 32.108242 negative MGI_C57BL6J_1859310 Asah2 NCBI_Gene:54447,ENSEMBL:ENSMUSG00000024887 MGI:1859310 protein coding gene N-acylsphingosine amidohydrolase 2
19 pseudogene 32.073335 32.074926 positive MGI_C57BL6J_3645706 Gm8943 NCBI_Gene:668042 MGI:3645706 pseudogene predicted gene 8943
19 gene 32.122727 32.389714 negative MGI_C57BL6J_2444110 Sgms1 NCBI_Gene:208449,ENSEMBL:ENSMUSG00000040451 MGI:2444110 protein coding gene sphingomyelin synthase 1
19 gene 32.204182 32.209273 negative MGI_C57BL6J_6302997 Gm50210 ENSEMBL:ENSMUSG00000118064 MGI:6302997 lncRNA gene predicted gene, 50210
19 gene 32.389216 32.391190 positive MGI_C57BL6J_1914438 2700046G09Rik NCBI_Gene:67188,ENSEMBL:ENSMUSG00000097787 MGI:1914438 lncRNA gene RIKEN cDNA 2700046G09 gene
19 pseudogene 32.423192 32.423582 positive MGI_C57BL6J_5621501 Gm38616 NCBI_Gene:102642581,ENSEMBL:ENSMUSG00000118355 MGI:5621501 pseudogene predicted gene, 38616
19 pseudogene 32.439941 32.441024 negative MGI_C57BL6J_3779973 Gm9563 NCBI_Gene:672490,ENSEMBL:ENSMUSG00000118329 MGI:3779973 pseudogene predicted gene 9563
19 pseudogene 32.465865 32.466578 negative MGI_C57BL6J_3642682 Rpl9-ps6 NCBI_Gene:100042823,ENSEMBL:ENSMUSG00000062456 MGI:3642682 pseudogene ribosomal protein L9, pseudogene 6
19 gene 32.470601 32.483595 negative MGI_C57BL6J_5826296 Gm46659 NCBI_Gene:108168420 MGI:5826296 lncRNA gene predicted gene, 46659
19 gene 32.485769 32.515370 positive MGI_C57BL6J_1336159 Minpp1 NCBI_Gene:17330,ENSEMBL:ENSMUSG00000024896 MGI:1336159 protein coding gene multiple inositol polyphosphate histidine phosphatase 1
19 gene 32.543347 32.563611 positive MGI_C57BL6J_5595578 Gm36419 NCBI_Gene:102640323,ENSEMBL:ENSMUSG00000118168 MGI:5595578 lncRNA gene predicted gene, 36419
19 gene 32.595645 32.667187 positive MGI_C57BL6J_1330223 Papss2 NCBI_Gene:23972,ENSEMBL:ENSMUSG00000024899 MGI:1330223 protein coding gene 3’-phosphoadenosine 5’-phosphosulfate synthase 2
19 pseudogene 32.658479 32.660200 negative MGI_C57BL6J_5595651 Gm36492 NCBI_Gene:102640429 MGI:5595651 pseudogene predicted gene, 36492
19 gene 32.671638 32.739786 negative MGI_C57BL6J_1915229 Atad1 NCBI_Gene:67979,ENSEMBL:ENSMUSG00000013662 MGI:1915229 protein coding gene ATPase family, AAA domain containing 1
19 gene 32.754378 32.756612 negative MGI_C57BL6J_5595725 Gm36566 NCBI_Gene:102640527 MGI:5595725 protein coding gene predicted gene, 36566
19 gene 32.757497 32.826160 positive MGI_C57BL6J_109583 Pten NCBI_Gene:19211,ENSEMBL:ENSMUSG00000013663 MGI:109583 protein coding gene phosphatase and tensin homolog
19 gene 32.933345 32.939008 positive MGI_C57BL6J_5595933 Gm36774 NCBI_Gene:102640791 MGI:5595933 lncRNA gene predicted gene, 36774
19 gene 32.959987 32.976159 positive MGI_C57BL6J_5596073 Gm36914 NCBI_Gene:102640981 MGI:5596073 lncRNA gene predicted gene, 36914
19 gene 32.966066 32.980390 negative MGI_C57BL6J_5596019 Gm36860 NCBI_Gene:102640908,ENSEMBL:ENSMUSG00000117664 MGI:5596019 lncRNA gene predicted gene, 36860
19 gene 32.969950 32.970308 negative MGI_C57BL6J_5452259 Gm22482 ENSEMBL:ENSMUSG00000084512 MGI:5452259 unclassified non-coding RNA gene predicted gene, 22482
19 gene 33.039471 33.074928 negative MGI_C57BL6J_5624720 Gm41835 NCBI_Gene:105246561 MGI:5624720 lncRNA gene predicted gene, 41835
19 gene 33.070072 33.102167 positive MGI_C57BL6J_5589022 Gm29863 NCBI_Gene:102631554,ENSEMBL:ENSMUSG00000117914 MGI:5589022 lncRNA gene predicted gene, 29863
19 gene 33.122647 33.134819 positive MGI_C57BL6J_5589105 Gm29946 NCBI_Gene:102631663,ENSEMBL:ENSMUSG00000118196 MGI:5589105 lncRNA gene predicted gene, 29946
19 pseudogene 33.137744 33.392295 negative MGI_C57BL6J_1915045 Rnls NCBI_Gene:67795,ENSEMBL:ENSMUSG00000071573 MGI:1915045 polymorphic pseudogene renalase, FAD-dependent amine oxidase
19 gene 33.157112 33.157201 positive MGI_C57BL6J_4950409 Mir3970 miRBase:MI0016980,NCBI_Gene:100628575,ENSEMBL:ENSMUSG00000106278 MGI:4950409 miRNA gene microRNA 3970
19 pseudogene 33.353066 33.354120 negative MGI_C57BL6J_5010027 Gm17842 NCBI_Gene:100415967 MGI:5010027 pseudogene predicted gene, 17842
19 gene 33.392253 33.392745 negative MGI_C57BL6J_1914484 2810449D17Rik NA NA unclassified non-coding RNA gene RIKEN cDNA 2810449D17 gene
19 gene 33.392433 33.420370 positive MGI_C57BL6J_5589157 Gm29998 NCBI_Gene:102631731 MGI:5589157 lncRNA gene predicted gene, 29998
19 pseudogene 33.405917 33.420642 negative MGI_C57BL6J_3779701 Gm7237 NCBI_Gene:638381,ENSEMBL:ENSMUSG00000087112 MGI:3779701 pseudogene predicted gene 7237
19 pseudogene 33.447613 33.447798 negative MGI_C57BL6J_5011909 Gm19724 NCBI_Gene:102631943,ENSEMBL:ENSMUSG00000118289 MGI:5011909 pseudogene predicted gene, 19724
19 pseudogene 33.459609 33.473191 negative MGI_C57BL6J_3648531 Lipo5 NCBI_Gene:668095,ENSEMBL:ENSMUSG00000086875 MGI:3648531 pseudogene lipase, member O5
19 gene 33.498037 33.517780 negative MGI_C57BL6J_3779637 Lipo4 NCBI_Gene:628236,ENSEMBL:ENSMUSG00000079344 MGI:3779637 protein coding gene lipase, member O4
19 pseudogene 33.550198 33.550397 negative MGI_C57BL6J_6303038 Gm50233 ENSEMBL:ENSMUSG00000118121 MGI:6303038 pseudogene predicted gene, 50233
19 gene 33.555160 33.761951 negative MGI_C57BL6J_2147592 Lipo3 NCBI_Gene:381236,ENSEMBL:ENSMUSG00000024766 MGI:2147592 protein coding gene lipase, member O3
19 gene 33.589971 33.590999 positive MGI_C57BL6J_1916554 1700001A13Rik NA NA unclassified gene RIKEN cDNA 1700001A13 gene
19 gene 33.592607 33.592713 negative MGI_C57BL6J_5530822 Gm27440 ENSEMBL:ENSMUSG00000098770 MGI:5530822 miRNA gene predicted gene, 27440
19 gene 33.612707 33.625252 negative MGI_C57BL6J_3647649 Gm8978 NCBI_Gene:668106,ENSEMBL:ENSMUSG00000086812 MGI:3647649 protein coding gene predicted gene 8978
19 pseudogene 33.668266 33.668463 negative MGI_C57BL6J_5011940 Gm19755 NCBI_Gene:102632180,ENSEMBL:ENSMUSG00000118360 MGI:5011940 pseudogene predicted gene, 19755
19 pseudogene 33.673329 33.673928 negative MGI_C57BL6J_5010478 Gm18293 NCBI_Gene:100416852,ENSEMBL:ENSMUSG00000117667 MGI:5010478 pseudogene predicted gene, 18293
19 pseudogene 33.674073 33.688481 negative MGI_C57BL6J_3644463 Gm8980 NCBI_Gene:668112,ENSEMBL:ENSMUSG00000085924 MGI:3644463 pseudogene predicted gene 8980
19 gene 33.719670 33.762109 negative MGI_C57BL6J_3644466 Lipo2 NCBI_Gene:101055671,ENSEMBL:ENSMUSG00000087303 MGI:3644466 protein coding gene lipase, member O2
19 gene 33.775498 33.787459 negative MGI_C57BL6J_3647308 Lipo1 NCBI_Gene:329055,ENSEMBL:ENSMUSG00000079342 MGI:3647308 protein coding gene lipase, member O1
19 pseudogene 33.822897 33.826711 positive MGI_C57BL6J_3645618 Gm5519 NCBI_Gene:433241,ENSEMBL:ENSMUSG00000037603 MGI:3645618 pseudogene predicted pseudogene 5519
19 pseudogene 33.838827 33.842598 negative MGI_C57BL6J_3647410 Gm8988 ENSEMBL:ENSMUSG00000085934 MGI:3647410 pseudogene predicted gene 8988
19 pseudogene 33.853164 33.872207 negative MGI_C57BL6J_6302861 Gm50120 ENSEMBL:ENSMUSG00000117821 MGI:6302861 pseudogene predicted gene, 50120
19 gene 33.954235 33.954341 positive MGI_C57BL6J_5452872 Gm23095 ENSEMBL:ENSMUSG00000065380 MGI:5452872 snRNA gene predicted gene, 23095
19 gene 33.961187 33.976813 positive MGI_C57BL6J_1914967 Lipf NCBI_Gene:67717,ENSEMBL:ENSMUSG00000024768 MGI:1914967 protein coding gene lipase, gastric
19 gene 34.008254 34.047903 positive MGI_C57BL6J_2679259 Lipk NCBI_Gene:240633,ENSEMBL:ENSMUSG00000024771 MGI:2679259 protein coding gene lipase, family member K
19 gene 34.056140 34.058360 negative MGI_C57BL6J_5590459 Gm31300 NCBI_Gene:102633486,ENSEMBL:ENSMUSG00000118302 MGI:5590459 lncRNA gene predicted gene, 31300
19 gene 34.067058 34.085946 positive MGI_C57BL6J_1917416 Lipn NCBI_Gene:70166,ENSEMBL:ENSMUSG00000024770 MGI:1917416 protein coding gene lipase, family member N
19 gene 34.068931 34.069054 positive MGI_C57BL6J_5453111 Gm23334 ENSEMBL:ENSMUSG00000080678 MGI:5453111 miRNA gene predicted gene, 23334
19 gene 34.100933 34.122687 positive MGI_C57BL6J_1926003 Lipm NCBI_Gene:78753,ENSEMBL:ENSMUSG00000056078 MGI:1926003 protein coding gene lipase, family member M
19 gene 34.121469 34.166053 negative MGI_C57BL6J_1277101 Ankrd22 NCBI_Gene:52024,ENSEMBL:ENSMUSG00000024774 MGI:1277101 protein coding gene ankyrin repeat domain 22
19 gene 34.192186 34.240333 positive MGI_C57BL6J_1923880 Stambpl1 NCBI_Gene:76630,ENSEMBL:ENSMUSG00000024776 MGI:1923880 protein coding gene STAM binding protein like 1
19 gene 34.240336 34.255590 negative MGI_C57BL6J_87909 Acta2 NCBI_Gene:11475,ENSEMBL:ENSMUSG00000035783 MGI:87909 protein coding gene actin, alpha 2, smooth muscle, aorta
19 gene 34.256636 34.278225 negative MGI_C57BL6J_5590514 Gm31355 NCBI_Gene:102633559 MGI:5590514 lncRNA gene predicted gene, 31355
19 pseudogene 34.284280 34.284537 negative MGI_C57BL6J_6303047 Gm50239 ENSEMBL:ENSMUSG00000118066 MGI:6303047 pseudogene predicted gene, 50239
19 gene 34.290659 34.327775 positive MGI_C57BL6J_95484 Fas NCBI_Gene:14102,ENSEMBL:ENSMUSG00000024778 MGI:95484 protein coding gene Fas (TNF receptor superfamily member 6)
19 gene 34.294137 34.294295 positive MGI_C57BL6J_5531200 Gm27818 ENSEMBL:ENSMUSG00000098670 MGI:5531200 unclassified non-coding RNA gene predicted gene, 27818
19 gene 34.395647 34.395755 negative MGI_C57BL6J_5452837 Gm23060 ENSEMBL:ENSMUSG00000076300 MGI:5452837 miRNA gene predicted gene, 23060
19 gene 34.473778 34.475164 negative MGI_C57BL6J_1333869 Ch25h NCBI_Gene:12642,ENSEMBL:ENSMUSG00000050370 MGI:1333869 protein coding gene cholesterol 25-hydroxylase
19 gene 34.474808 34.481546 positive MGI_C57BL6J_5477396 Gm26902 ENSEMBL:ENSMUSG00000097558 MGI:5477396 lncRNA gene predicted gene, 26902
19 gene 34.492316 34.527474 negative MGI_C57BL6J_96789 Lipa NCBI_Gene:16889,ENSEMBL:ENSMUSG00000024781 MGI:96789 protein coding gene lysosomal acid lipase A
19 gene 34.543288 34.544729 negative MGI_C57BL6J_5590576 Gm31417 NCBI_Gene:102633635 MGI:5590576 lncRNA gene predicted gene, 31417
19 pseudogene 34.549264 34.549392 positive MGI_C57BL6J_6303079 Gm50257 ENSEMBL:ENSMUSG00000118048 MGI:6303079 pseudogene predicted gene, 50257
19 gene 34.550549 34.576534 positive MGI_C57BL6J_99449 Ifit2 NCBI_Gene:15958,ENSEMBL:ENSMUSG00000045932 MGI:99449 protein coding gene interferon-induced protein with tetratricopeptide repeats 2
19 gene 34.583142 34.588982 positive MGI_C57BL6J_1101055 Ifit3 NCBI_Gene:15959,ENSEMBL:ENSMUSG00000074896 MGI:1101055 protein coding gene interferon-induced protein with tetratricopeptide repeats 3
19 gene 34.592888 34.662997 negative MGI_C57BL6J_3650685 Ifit1bl1 NCBI_Gene:667373,ENSEMBL:ENSMUSG00000079339 MGI:3650685 protein coding gene interferon induced protein with tetratricpeptide repeats 1B like 1
19 gene 34.607540 34.613409 positive MGI_C57BL6J_3698419 Ifit3b NCBI_Gene:667370,ENSEMBL:ENSMUSG00000062488 MGI:3698419 protein coding gene interferon-induced protein with tetratricopeptide repeats 3B
19 gene 34.617049 34.640743 negative MGI_C57BL6J_2148249 Ifit1bl2 NCBI_Gene:112419,ENSEMBL:ENSMUSG00000067297 MGI:2148249 protein coding gene interferon induced protein with tetratricopeptide repeats 1B like 2
19 pseudogene 34.623630 34.624804 positive MGI_C57BL6J_5010061 Cnn2-ps NCBI_Gene:100416023,ENSEMBL:ENSMUSG00000118260 MGI:5010061 pseudogene calponin2, pseudogene
19 gene 34.640871 34.650009 positive MGI_C57BL6J_99450 Ifit1 NCBI_Gene:15957,ENSEMBL:ENSMUSG00000034459 MGI:99450 protein coding gene interferon-induced protein with tetratricopeptide repeats 1
19 gene 34.668401 34.747823 negative MGI_C57BL6J_2147716 Slc16a12 NCBI_Gene:240638,ENSEMBL:ENSMUSG00000009378 MGI:2147716 protein coding gene solute carrier family 16 (monocarboxylic acid transporters), member 12
19 pseudogene 34.682183 34.684822 negative MGI_C57BL6J_5826291 Gm46654 NCBI_Gene:108168415 MGI:5826291 pseudogene predicted gene, 46654
19 pseudogene 34.710008 34.711016 positive MGI_C57BL6J_5010610 Gm18425 NCBI_Gene:100417152,ENSEMBL:ENSMUSG00000118098 MGI:5010610 pseudogene predicted gene, 18425
19 gene 34.750510 34.750613 positive MGI_C57BL6J_5530858 Gm27476 ENSEMBL:ENSMUSG00000098742 MGI:5530858 miRNA gene predicted gene, 27476
19 pseudogene 34.773881 34.774451 positive MGI_C57BL6J_6302944 Gm50173 ENSEMBL:ENSMUSG00000118083 MGI:6302944 pseudogene predicted gene, 50173
19 gene 34.796178 34.796338 positive MGI_C57BL6J_5451859 Gm22082 ENSEMBL:ENSMUSG00000088212 MGI:5451859 snRNA gene predicted gene, 22082
19 pseudogene 34.804262 34.804759 positive MGI_C57BL6J_6302856 Gm50116 ENSEMBL:ENSMUSG00000117945 MGI:6302856 pseudogene predicted gene, 50116
19 gene 34.806935 34.879593 negative MGI_C57BL6J_1922985 Pank1 NCBI_Gene:75735,ENSEMBL:ENSMUSG00000033610 MGI:1922985 protein coding gene pantothenate kinase 1
19 gene 34.820687 34.820773 negative MGI_C57BL6J_3619063 Mir107 miRBase:MI0000684,NCBI_Gene:723826,ENSEMBL:ENSMUSG00000065594 MGI:3619063 miRNA gene microRNA 107
19 gene 34.922341 34.975750 positive MGI_C57BL6J_2444576 Kif20b NCBI_Gene:240641,ENSEMBL:ENSMUSG00000024795 MGI:2444576 protein coding gene kinesin family member 20B
19 gene 34.965396 34.965469 positive MGI_C57BL6J_3837023 Mir1950 miRBase:MI0009941,NCBI_Gene:100316775,ENSEMBL:ENSMUSG00000089151 MGI:3837023 miRNA gene microRNA 1950
19 pseudogene 35.051830 35.052744 negative MGI_C57BL6J_3643322 Gm5248 NCBI_Gene:383464,ENSEMBL:ENSMUSG00000101966 MGI:3643322 pseudogene predicted gene 5248
19 gene 35.054465 35.083440 positive MGI_C57BL6J_6302884 Gm50137 ENSEMBL:ENSMUSG00000117865 MGI:6302884 lncRNA gene predicted gene, 50137
19 gene 35.117283 35.133451 positive MGI_C57BL6J_6302890 Gm50140 ENSEMBL:ENSMUSG00000117973 MGI:6302890 lncRNA gene predicted gene, 50140
19 gene 35.151913 35.156629 positive MGI_C57BL6J_5590727 Gm31568 NCBI_Gene:102633838 MGI:5590727 lncRNA gene predicted gene, 31568
19 gene 35.203235 35.203366 positive MGI_C57BL6J_5453783 Gm24006 ENSEMBL:ENSMUSG00000089087 MGI:5453783 snoRNA gene predicted gene, 24006
19 gene 35.276453 35.276522 negative MGI_C57BL6J_5452852 Gm23075 ENSEMBL:ENSMUSG00000093373 MGI:5452852 miRNA gene predicted gene, 23075
19 gene 35.605674 35.605804 negative MGI_C57BL6J_5452630 Gm22853 ENSEMBL:ENSMUSG00000092715 MGI:5452630 rRNA gene predicted gene, 22853
19 gene 35.700349 35.766127 negative MGI_C57BL6J_5624721 Gm41836 NCBI_Gene:105246562,ENSEMBL:ENSMUSG00000118212 MGI:5624721 lncRNA gene predicted gene, 41836
19 gene 35.759933 35.760065 negative MGI_C57BL6J_5455388 Gm25611 ENSEMBL:ENSMUSG00000077205 MGI:5455388 snoRNA gene predicted gene, 25611
19 gene 35.835217 35.924735 negative MGI_C57BL6J_3028035 A830019P07Rik NCBI_Gene:329056,ENSEMBL:ENSMUSG00000094707 MGI:3028035 lncRNA gene RIKEN cDNA A830019P07 gene
19 pseudogene 35.870079 35.870772 positive MGI_C57BL6J_5010111 Gm17926 NCBI_Gene:100416119 MGI:5010111 pseudogene predicted gene, 17926
19 gene 35.958415 36.058287 negative MGI_C57BL6J_99841 Htr7 NCBI_Gene:15566,ENSEMBL:ENSMUSG00000024798 MGI:99841 protein coding gene 5-hydroxytryptamine (serotonin) receptor 7
19 gene 36.083689 36.104777 positive MGI_C57BL6J_1859683 Rpp30 NCBI_Gene:54364,ENSEMBL:ENSMUSG00000024800 MGI:1859683 protein coding gene ribonuclease P/MRP 30 subunit
19 gene 36.111961 36.120099 negative MGI_C57BL6J_1097717 Ankrd1 NCBI_Gene:107765,ENSEMBL:ENSMUSG00000024803 MGI:1097717 protein coding gene ankyrin repeat domain 1 (cardiac muscle)
19 gene 36.182580 36.221676 positive MGI_C57BL6J_5591240 Gm32081 NCBI_Gene:102634520,ENSEMBL:ENSMUSG00000117998 MGI:5591240 lncRNA gene predicted gene, 32081
19 gene 36.215016 36.264437 negative MGI_C57BL6J_5591186 Gm32027 NCBI_Gene:102634446,ENSEMBL:ENSMUSG00000117990 MGI:5591186 lncRNA gene predicted gene, 32027
19 gene 36.235979 36.243323 positive MGI_C57BL6J_5826301 Gm46664 NCBI_Gene:108168426 MGI:5826301 lncRNA gene predicted gene, 46664
19 gene 36.251727 36.256336 positive MGI_C57BL6J_6302902 Gm50147 ENSEMBL:ENSMUSG00000118032 MGI:6302902 lncRNA gene predicted gene, 50147
19 pseudogene 36.339044 36.339931 negative MGI_C57BL6J_5011345 Gm19160 NCBI_Gene:100418358 MGI:5011345 pseudogene predicted gene, 19160
19 gene 36.347440 36.460970 positive MGI_C57BL6J_1923505 Pcgf5 NCBI_Gene:76073,ENSEMBL:ENSMUSG00000024805 MGI:1923505 protein coding gene polycomb group ring finger 5
19 gene 36.347614 36.348298 negative MGI_C57BL6J_6096874 Gm47735 ENSEMBL:ENSMUSG00000114859 MGI:6096874 lncRNA gene predicted gene, 47735
19 pseudogene 36.361343 36.361811 positive MGI_C57BL6J_6096932 Gm47773 ENSEMBL:ENSMUSG00000114285 MGI:6096932 pseudogene predicted gene, 47773
19 gene 36.384792 36.384897 negative MGI_C57BL6J_5452947 Gm23170 ENSEMBL:ENSMUSG00000087783 MGI:5452947 snRNA gene predicted gene, 23170
19 pseudogene 36.404404 36.406211 positive MGI_C57BL6J_3647150 Gm9042 NCBI_Gene:668201,ENSEMBL:ENSMUSG00000114409 MGI:3647150 pseudogene predicted gene 9042
19 gene 36.448992 36.451157 negative MGI_C57BL6J_3642424 F530104D19Rik ENSEMBL:ENSMUSG00000114235 MGI:3642424 lncRNA gene RIKEN cDNA F530104D19 gene
19 gene 36.533923 36.538802 negative MGI_C57BL6J_5591302 Gm32143 NCBI_Gene:102634602 MGI:5591302 lncRNA gene predicted gene, 32143
19 gene 36.552925 36.553977 negative MGI_C57BL6J_5624723 Gm41838 NCBI_Gene:105246565 MGI:5624723 lncRNA gene predicted gene, 41838
19 gene 36.554053 36.621135 positive MGI_C57BL6J_2442663 Hectd2 NCBI_Gene:226098,ENSEMBL:ENSMUSG00000041180 MGI:2442663 protein coding gene HECT domain E3 ubiquitin protein ligase 2
19 gene 36.614052 36.705641 negative MGI_C57BL6J_1919243 Hectd2os NCBI_Gene:668215,ENSEMBL:ENSMUSG00000087579 MGI:1919243 antisense lncRNA gene Hectd2, opposite strand
19 gene 36.731731 36.736653 negative MGI_C57BL6J_1858229 Ppp1r3c NCBI_Gene:53412,ENSEMBL:ENSMUSG00000067279 MGI:1858229 protein coding gene protein phosphatase 1, regulatory subunit 3C
19 pseudogene 36.818648 36.818930 positive MGI_C57BL6J_6302850 Gm50112 ENSEMBL:ENSMUSG00000117938 MGI:6302850 pseudogene predicted gene, 50112
19 gene 36.834230 36.893477 positive MGI_C57BL6J_1921743 Tnks2 NCBI_Gene:74493,ENSEMBL:ENSMUSG00000024811 MGI:1921743 protein coding gene tankyrase, TRF1-interacting ankyrin-related ADP-ribose polymerase 2
19 gene 36.917550 36.919615 negative MGI_C57BL6J_1919764 Fgfbp3 NCBI_Gene:72514,ENSEMBL:ENSMUSG00000047632 MGI:1919764 protein coding gene fibroblast growth factor binding protein 3
19 gene 36.926079 37.014057 positive MGI_C57BL6J_2147538 Btaf1 NCBI_Gene:107182,ENSEMBL:ENSMUSG00000040565 MGI:2147538 protein coding gene B-TFIID TATA-box binding protein associated factor 1
19 gene 37.019341 37.208601 negative MGI_C57BL6J_2443075 Cpeb3 NCBI_Gene:208922,ENSEMBL:ENSMUSG00000039652 MGI:2443075 protein coding gene cytoplasmic polyadenylation element binding protein 3
19 gene 37.149085 37.149162 negative MGI_C57BL6J_5452491 Gm22714 ENSEMBL:ENSMUSG00000080544 MGI:5452491 ribozyme gene predicted gene, 22714
19 gene 37.173843 37.196541 positive MGI_C57BL6J_2443002 A330032B11Rik NCBI_Gene:319931,ENSEMBL:ENSMUSG00000097591 MGI:2443002 lncRNA gene RIKEN cDNA A330032B11 gene
19 gene 37.179186 37.179291 positive MGI_C57BL6J_5453695 Gm23918 ENSEMBL:ENSMUSG00000092994 MGI:5453695 rRNA gene predicted gene, 23918
19 gene 37.207527 37.224457 positive MGI_C57BL6J_1915207 March5 NCBI_Gene:69104,ENSEMBL:ENSMUSG00000023307 MGI:1915207 protein coding gene membrane-associated ring finger (C3HC4) 5
19 gene 37.233382 37.233484 negative MGI_C57BL6J_5455045 Gm25268 ENSEMBL:ENSMUSG00000089143 MGI:5455045 snRNA gene predicted gene, 25268
19 pseudogene 37.233603 37.234560 positive MGI_C57BL6J_3643992 Gm9056 NCBI_Gene:668230 MGI:3643992 pseudogene predicted gene 9056
19 gene 37.258423 37.264095 negative MGI_C57BL6J_1924309 4931408D14Rik NCBI_Gene:77059 MGI:1924309 lncRNA gene RIKEN cDNA 4931408D14 gene
19 gene 37.268741 37.337852 negative MGI_C57BL6J_96412 Ide NCBI_Gene:15925,ENSEMBL:ENSMUSG00000056999 MGI:96412 protein coding gene insulin degrading enzyme
19 pseudogene 37.295093 37.295837 negative MGI_C57BL6J_3782343 Rpl10-ps6 NCBI_Gene:100043010,ENSEMBL:ENSMUSG00000080885 MGI:3782343 pseudogene ribosomal protein L10, pseudogene 6
19 gene 37.376403 37.421859 positive MGI_C57BL6J_1098231 Kif11 NCBI_Gene:16551,ENSEMBL:ENSMUSG00000012443 MGI:1098231 protein coding gene kinesin family member 11
19 pseudogene 37.388339 37.389495 positive MGI_C57BL6J_3648745 Gm8663 NCBI_Gene:667490,ENSEMBL:ENSMUSG00000117988 MGI:3648745 pseudogene predicted gene 8663
19 pseudogene 37.413424 37.413878 negative MGI_C57BL6J_5826286 Gm46649 NCBI_Gene:108168410,ENSEMBL:ENSMUSG00000118211 MGI:5826286 pseudogene predicted gene, 46649
19 gene 37.432909 37.434656 negative MGI_C57BL6J_5611573 Gm38345 ENSEMBL:ENSMUSG00000102353 MGI:5611573 unclassified gene predicted gene, 38345
19 gene 37.434810 37.440731 positive MGI_C57BL6J_96086 Hhex NCBI_Gene:15242,ENSEMBL:ENSMUSG00000024986 MGI:96086 protein coding gene hematopoietically expressed homeobox
19 gene 37.463746 37.463851 positive MGI_C57BL6J_5452803 Gm23026 ENSEMBL:ENSMUSG00000089397 MGI:5452803 snRNA gene predicted gene, 23026
19 gene 37.465253 37.471834 positive MGI_C57BL6J_1925890 1700122C19Rik NCBI_Gene:78640,ENSEMBL:ENSMUSG00000117800 MGI:1925890 lncRNA gene RIKEN cDNA 1700122C19 gene
19 gene 37.493599 37.495964 positive MGI_C57BL6J_5591453 Gm32294 NCBI_Gene:102634793 MGI:5591453 lncRNA gene predicted gene, 32294
19 gene 37.536763 37.684059 positive MGI_C57BL6J_1351611 Exoc6 NCBI_Gene:107371,ENSEMBL:ENSMUSG00000053799 MGI:1351611 protein coding gene exocyst complex component 6
19 gene 37.545104 37.546314 negative MGI_C57BL6J_5624727 Gm41842 NCBI_Gene:105246569 MGI:5624727 lncRNA gene predicted gene, 41842
19 gene 37.677387 37.697564 negative MGI_C57BL6J_5591501 Gm32342 NCBI_Gene:102634858 MGI:5591501 lncRNA gene predicted gene, 32342
19 gene 37.685195 37.693398 positive MGI_C57BL6J_2679699 Cyp26c1 NCBI_Gene:546726,ENSEMBL:ENSMUSG00000062432 MGI:2679699 protein coding gene cytochrome P450, family 26, subfamily c, polypeptide 1
19 gene 37.697732 37.701536 positive MGI_C57BL6J_1096359 Cyp26a1 NCBI_Gene:13082,ENSEMBL:ENSMUSG00000024987 MGI:1096359 protein coding gene cytochrome P450, family 26, subfamily a, polypeptide 1
19 pseudogene 37.722761 37.723516 negative MGI_C57BL6J_3647635 Gm9066 NCBI_Gene:668248,ENSEMBL:ENSMUSG00000117989 MGI:3647635 pseudogene predicted gene 9066
19 pseudogene 37.784259 37.785765 positive MGI_C57BL6J_3644658 Gm9067 NCBI_Gene:668251,ENSEMBL:ENSMUSG00000117939 MGI:3644658 pseudogene predicted gene 9067
19 pseudogene 37.870267 37.872256 positive MGI_C57BL6J_3647440 Gm4757 NCBI_Gene:209281,ENSEMBL:ENSMUSG00000118115 MGI:3647440 pseudogene predicted gene 4757
19 gene 37.899036 38.043577 negative MGI_C57BL6J_1919192 Myof NCBI_Gene:226101,ENSEMBL:ENSMUSG00000048612 MGI:1919192 protein coding gene myoferlin
19 gene 38.051774 38.054528 negative MGI_C57BL6J_3588250 I830134H01Rik ENSEMBL:ENSMUSG00000069554 MGI:3588250 lncRNA gene RIKEN cDNA I830134H01 gene
19 gene 38.054981 38.074425 positive MGI_C57BL6J_1921357 Cep55 NCBI_Gene:74107,ENSEMBL:ENSMUSG00000024989 MGI:1921357 protein coding gene centrosomal protein 55
19 gene 38.071929 38.072053 positive MGI_C57BL6J_5453077 Gm23300 ENSEMBL:ENSMUSG00000064646 MGI:5453077 snoRNA gene predicted gene, 23300
19 gene 38.097071 38.114263 positive MGI_C57BL6J_2147577 Ffar4 NCBI_Gene:107221,ENSEMBL:ENSMUSG00000054200 MGI:2147577 protein coding gene free fatty acid receptor 4
19 gene 38.116620 38.125321 negative MGI_C57BL6J_97879 Rbp4 NCBI_Gene:19662,ENSEMBL:ENSMUSG00000024990 MGI:97879 protein coding gene retinol binding protein 4, plasma
19 gene 38.125754 38.134496 negative MGI_C57BL6J_5591599 Gm32440 NCBI_Gene:102634991 MGI:5591599 lncRNA gene predicted gene, 32440
19 gene 38.132781 38.183958 positive MGI_C57BL6J_105956 Pde6c NCBI_Gene:110855,ENSEMBL:ENSMUSG00000024992 MGI:105956 protein coding gene phosphodiesterase 6C, cGMP specific, cone, alpha prime
19 gene 38.188477 38.224517 negative MGI_C57BL6J_1917817 Fra10ac1 NCBI_Gene:70567,ENSEMBL:ENSMUSG00000054237 MGI:1917817 protein coding gene FRA10AC1 homolog (human)
19 gene 38.257836 38.260793 negative MGI_C57BL6J_5591733 Gm32574 NCBI_Gene:102635170 MGI:5591733 lncRNA gene predicted gene, 32574
19 gene 38.257928 38.263285 positive MGI_C57BL6J_5591650 Gm32491 NCBI_Gene:102635059 MGI:5591650 lncRNA gene predicted gene, 32491
19 gene 38.264535 38.272565 negative MGI_C57BL6J_5591930 Gm32771 NCBI_Gene:102635432 MGI:5591930 lncRNA gene predicted gene, 32771
19 gene 38.264536 38.312214 positive MGI_C57BL6J_1861691 Lgi1 NCBI_Gene:56839,ENSEMBL:ENSMUSG00000067242 MGI:1861691 protein coding gene leucine-rich repeat LGI family, member 1
19 pseudogene 38.287951 38.288224 positive MGI_C57BL6J_6302892 Gm50141 ENSEMBL:ENSMUSG00000118242 MGI:6302892 pseudogene predicted gene, 50141
19 gene 38.300083 38.315270 negative MGI_C57BL6J_5662860 Gm42723 ENSEMBL:ENSMUSG00000105709 MGI:5662860 lncRNA gene predicted gene 42723
19 gene 38.311058 38.327048 negative MGI_C57BL6J_3641826 Gm9886 NCBI_Gene:105246571 MGI:3641826 lncRNA gene predicted gene 9886
19 pseudogene 38.342179 38.342614 negative MGI_C57BL6J_6302907 Gm50150 ENSEMBL:ENSMUSG00000118381 MGI:6302907 pseudogene predicted gene, 50150
19 gene 38.348636 38.350079 positive MGI_C57BL6J_5592119 Gm32960 NCBI_Gene:102635685 MGI:5592119 lncRNA gene predicted gene, 32960
19 gene 38.352239 38.358506 negative MGI_C57BL6J_5592195 Gm33036 NCBI_Gene:102635788 MGI:5592195 lncRNA gene predicted gene, 33036
19 gene 38.379292 38.381215 positive MGI_C57BL6J_5624729 Gm41844 NCBI_Gene:105246572 MGI:5624729 protein coding gene predicted gene, 41844
19 pseudogene 38.384566 38.385514 negative MGI_C57BL6J_6302915 Gm50155 ENSEMBL:ENSMUSG00000117920 MGI:6302915 pseudogene predicted gene, 50155
19 pseudogene 38.386963 38.388161 negative MGI_C57BL6J_5011121 Gm18936 NCBI_Gene:100417987,ENSEMBL:ENSMUSG00000118335 MGI:5011121 pseudogene predicted gene, 18936
19 gene 38.395980 38.405610 positive MGI_C57BL6J_2444789 Slc35g1 NCBI_Gene:240660,ENSEMBL:ENSMUSG00000044026 MGI:2444789 protein coding gene solute carrier family 35, member G1
19 gene 38.458585 38.463554 positive MGI_C57BL6J_5826303 Gm46666 NCBI_Gene:108168429 MGI:5826303 lncRNA gene predicted gene, 46666
19 gene 38.473120 38.473202 negative MGI_C57BL6J_5454707 Gm24930 ENSEMBL:ENSMUSG00000088940 MGI:5454707 unclassified non-coding RNA gene predicted gene, 24930
19 gene 38.481109 38.785105 positive MGI_C57BL6J_1921305 Plce1 NCBI_Gene:74055,ENSEMBL:ENSMUSG00000024998 MGI:1921305 protein coding gene phospholipase C, epsilon 1
19 pseudogene 38.703444 38.704438 negative MGI_C57BL6J_3644350 Gm8717 NCBI_Gene:667587,ENSEMBL:ENSMUSG00000117935 MGI:3644350 pseudogene predicted gene 8717
19 gene 38.748760 38.752645 negative MGI_C57BL6J_5579697 Gm28991 ENSEMBL:ENSMUSG00000101079 MGI:5579697 lncRNA gene predicted gene 28991
19 gene 38.788121 38.819950 negative MGI_C57BL6J_1932610 Noc3l NCBI_Gene:57753,ENSEMBL:ENSMUSG00000024999 MGI:1932610 protein coding gene NOC3 like DNA replication regulator
19 gene 38.836579 38.919923 positive MGI_C57BL6J_2384803 Tbc1d12 NCBI_Gene:209478,ENSEMBL:ENSMUSG00000048720 MGI:2384803 protein coding gene TBC1D12: TBC1 domain family, member 12
19 gene 38.885242 38.885361 positive MGI_C57BL6J_5455615 Gm25838 ENSEMBL:ENSMUSG00000089545 MGI:5455615 unclassified non-coding RNA gene predicted gene, 25838
19 gene 38.930915 38.971051 positive MGI_C57BL6J_106209 Hells NCBI_Gene:15201,ENSEMBL:ENSMUSG00000025001 MGI:106209 protein coding gene helicase, lymphoid specific
19 pseudogene 38.976647 39.003627 positive MGI_C57BL6J_3716994 Cyp2c52-ps NCBI_Gene:209753,ENSEMBL:ENSMUSG00000114610 MGI:3716994 pseudogene cytochrome P450, family 2, subfamily c, polypeptide 52, pseudogene
19 gene 39.006938 39.042693 positive MGI_C57BL6J_1919332 Cyp2c55 NCBI_Gene:72082,ENSEMBL:ENSMUSG00000025002 MGI:1919332 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 55
19 gene 39.007026 39.007089 negative MGI_C57BL6J_5453577 Gm23800 ENSEMBL:ENSMUSG00000093303 MGI:5453577 miRNA gene predicted gene, 23800
19 pseudogene 39.052630 39.054824 negative MGI_C57BL6J_3782048 Gm3875 NCBI_Gene:100042507 MGI:3782048 pseudogene predicted gene 3875
19 gene 39.061006 39.093948 positive MGI_C57BL6J_1919553 Cyp2c65 NCBI_Gene:72303,ENSEMBL:ENSMUSG00000067231 MGI:1919553 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 65
19 gene 39.113898 39.187072 positive MGI_C57BL6J_1917138 Cyp2c66 NCBI_Gene:69888,ENSEMBL:ENSMUSG00000067229 MGI:1917138 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 66
19 pseudogene 39.229254 39.274985 positive MGI_C57BL6J_3646306 Cyp2c53-ps NCBI_Gene:638988,ENSEMBL:ENSMUSG00000093610 MGI:3646306 pseudogene cytochrome P450, family 2, subfamily c, polypeptide 53-ps
19 gene 39.269405 39.330713 positive MGI_C57BL6J_103238 Cyp2c29 NCBI_Gene:13095,ENSEMBL:ENSMUSG00000003053 MGI:103238 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 29
19 pseudogene 39.347367 39.360403 positive MGI_C57BL6J_3721925 Cyp2c72-ps NCBI_Gene:100125395,ENSEMBL:ENSMUSG00000118146 MGI:3721925 pseudogene cytochrome P450, family 2, subfamily c, polypeptide 72, pseudogene
19 gene 39.389556 39.463089 negative MGI_C57BL6J_1306819 Cyp2c38 NCBI_Gene:13097,ENSEMBL:ENSMUSG00000032808 MGI:1306819 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 38
19 gene 39.510822 39.568529 positive MGI_C57BL6J_1306818 Cyp2c39 NCBI_Gene:13098,ENSEMBL:ENSMUSG00000025003 MGI:1306818 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 39
19 gene 39.608842 39.649079 negative MGI_C57BL6J_3612288 Cyp2c67 NCBI_Gene:545288,ENSEMBL:ENSMUSG00000062624 MGI:3612288 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 67
19 gene 39.688834 39.741101 negative MGI_C57BL6J_3612287 Cyp2c68 NCBI_Gene:433247,ENSEMBL:ENSMUSG00000074882 MGI:3612287 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 68
19 gene 39.767071 39.812814 negative MGI_C57BL6J_1306815 Cyp2c40 NCBI_Gene:13099,ENSEMBL:ENSMUSG00000025004 MGI:1306815 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 40
19 gene 39.842660 39.886799 negative MGI_C57BL6J_3721049 Cyp2c69 NCBI_Gene:100043108,ENSEMBL:ENSMUSG00000092008 MGI:3721049 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 69
19 pseudogene 39.928044 39.952861 positive MGI_C57BL6J_3721924 Cyp2c71-ps NCBI_Gene:100125394,ENSEMBL:ENSMUSG00000117738 MGI:3721924 pseudogene cytochrome P450, family 2, subfamily c, polypeptide 71, pseudogene
19 gene 39.992424 40.012243 positive MGI_C57BL6J_1306806 Cyp2c37 NCBI_Gene:13096,ENSEMBL:ENSMUSG00000042248 MGI:1306806 protein coding gene cytochrome P450, family 2. subfamily c, polypeptide 37
19 gene 40.037940 40.073845 negative MGI_C57BL6J_3642960 Cyp2c54 NCBI_Gene:404195,ENSEMBL:ENSMUSG00000067225 MGI:3642960 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 54
19 gene 40.089679 40.113955 positive MGI_C57BL6J_2147497 Cyp2c50 NCBI_Gene:107141,ENSEMBL:ENSMUSG00000054827 MGI:2147497 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 50
19 gene 40.153353 40.187333 negative MGI_C57BL6J_2385878 Cyp2c70 NCBI_Gene:226105,ENSEMBL:ENSMUSG00000060613 MGI:2385878 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 70
19 pseudogene 40.189990 40.194415 positive MGI_C57BL6J_3647389 Gm5827 NCBI_Gene:545289,ENSEMBL:ENSMUSG00000117785 MGI:3647389 pseudogene predicted gene 5827
19 pseudogene 40.212364 40.213575 positive MGI_C57BL6J_3645079 Gm16470 NCBI_Gene:676923,ENSEMBL:ENSMUSG00000098091 MGI:3645079 pseudogene predicted pseudogene 16470
19 gene 40.221173 40.271842 negative MGI_C57BL6J_1860611 Pdlim1 NCBI_Gene:54132,ENSEMBL:ENSMUSG00000055044 MGI:1860611 protein coding gene PDZ and LIM domain 1 (elfin)
19 gene 40.271701 40.274454 positive MGI_C57BL6J_5624730 Gm41845 NCBI_Gene:105246573 MGI:5624730 lncRNA gene predicted gene, 41845
19 pseudogene 40.280951 40.282794 positive MGI_C57BL6J_3643821 Gm5693 NCBI_Gene:435599,ENSEMBL:ENSMUSG00000117793 MGI:3643821 pseudogene predicted gene 5693
19 gene 40.292040 40.513874 negative MGI_C57BL6J_700014 Sorbs1 NCBI_Gene:20411,ENSEMBL:ENSMUSG00000025006 MGI:700014 protein coding gene sorbin and SH3 domain containing 1
19 gene 40.297820 40.299555 positive MGI_C57BL6J_1925688 A930028N01Rik NCBI_Gene:78438,ENSEMBL:ENSMUSG00000114796 MGI:1925688 lncRNA gene RIKEN cDNA A930028N01 gene
19 gene 40.416249 40.416870 negative MGI_C57BL6J_1925672 9530039L23Rik NA NA unclassified gene RIKEN cDNA 9530039L23 gene
19 gene 40.458213 40.458965 negative MGI_C57BL6J_3642414 3010085J16Rik NA NA protein coding gene RIKEN cDNA 3010085J16 gene
19 gene 40.472755 40.474430 negative MGI_C57BL6J_1917735 5730409N24Rik NA NA unclassified gene RIKEN cDNA 5730409N24 gene
19 gene 40.474599 40.476539 negative MGI_C57BL6J_1918838 9130009M17Rik NA NA unclassified gene RIKEN cDNA 9130009M17 gene
19 gene 40.550257 40.588463 negative MGI_C57BL6J_1888908 Aldh18a1 NCBI_Gene:56454,ENSEMBL:ENSMUSG00000025007 MGI:1888908 protein coding gene aldehyde dehydrogenase 18 family, member A1
19 pseudogene 40.558919 40.561755 negative MGI_C57BL6J_3779625 Gm15801 NCBI_Gene:627166,ENSEMBL:ENSMUSG00000096592 MGI:3779625 pseudogene predicted gene 15801
19 gene 40.588535 40.594862 positive MGI_C57BL6J_5504157 Gm27042 NCBI_Gene:102636239,ENSEMBL:ENSMUSG00000097792 MGI:5504157 lncRNA gene predicted gene, 27042
19 gene 40.596446 40.612281 negative MGI_C57BL6J_1914840 Tctn3 NCBI_Gene:67590,ENSEMBL:ENSMUSG00000025008 MGI:1914840 protein coding gene tectonic family member 3
19 gene 40.611601 40.612996 positive MGI_C57BL6J_3712488 E130009M23Rik NA NA unclassified gene RIKEN cDNA E130009M23 gene
19 gene 40.612366 40.741602 positive MGI_C57BL6J_102805 Entpd1 NCBI_Gene:12495,ENSEMBL:ENSMUSG00000048120 MGI:102805 protein coding gene ectonucleoside triphosphate diphosphohydrolase 1
19 pseudogene 40.615886 40.616758 positive MGI_C57BL6J_3801732 Gm16027 NCBI_Gene:100417906,ENSEMBL:ENSMUSG00000090041 MGI:3801732 pseudogene predicted gene 16027
19 pseudogene 40.621776 40.624599 positive MGI_C57BL6J_3646027 Gm8783 NCBI_Gene:667723,ENSEMBL:ENSMUSG00000094388 MGI:3646027 pseudogene predicted pseudogene 8783
19 gene 40.644146 40.654035 positive MGI_C57BL6J_6302875 Gm50132 ENSEMBL:ENSMUSG00000117952 MGI:6302875 lncRNA gene predicted gene, 50132
19 gene 40.658272 40.661201 negative MGI_C57BL6J_5592464 Gm33305 NCBI_Gene:102636161 MGI:5592464 lncRNA gene predicted gene, 33305
19 gene 40.729437 40.731663 negative MGI_C57BL6J_5624731 Gm41846 NCBI_Gene:105246574 MGI:5624731 lncRNA gene predicted gene, 41846
19 gene 40.748753 40.829057 positive MGI_C57BL6J_3645359 Cc2d2b NCBI_Gene:668310,ENSEMBL:ENSMUSG00000108929 MGI:3645359 protein coding gene coiled-coil and C2 domain containing 2B
19 gene 40.816765 40.818268 negative MGI_C57BL6J_5592641 Gm33482 NCBI_Gene:102636408 MGI:5592641 lncRNA gene predicted gene, 33482
19 gene 40.830522 40.831855 negative MGI_C57BL6J_3645360 Gm9099 NA NA unclassified gene predicted gene 9099
19 gene 40.831279 40.848572 positive MGI_C57BL6J_2443297 Ccnj NCBI_Gene:240665,ENSEMBL:ENSMUSG00000025010 MGI:2443297 protein coding gene cyclin J
19 gene 40.868304 40.882639 positive MGI_C57BL6J_2686464 E030044B06Rik NCBI_Gene:381223,ENSEMBL:ENSMUSG00000097740 MGI:2686464 lncRNA gene RIKEN cDNA E030044B06 gene
19 gene 40.893933 40.917947 positive MGI_C57BL6J_1919922 Zfp518a NCBI_Gene:72672,ENSEMBL:ENSMUSG00000049164 MGI:1919922 protein coding gene zinc finger protein 518A
19 gene 40.894687 40.898391 positive MGI_C57BL6J_3053211 E130314M14Rik NA NA unclassified gene RIKEN cDNA E130314M14 gene
19 gene 40.894703 40.894789 positive MGI_C57BL6J_5530789 Mir8092 miRBase:MI0026019,NCBI_Gene:102466881,ENSEMBL:ENSMUSG00000099118 MGI:5530789 miRNA gene microRNA 8092
19 gene 40.928927 40.994535 negative MGI_C57BL6J_96878 Blnk NCBI_Gene:17060,ENSEMBL:ENSMUSG00000061132 MGI:96878 protein coding gene B cell linker
19 gene 41.004815 41.014643 negative MGI_C57BL6J_1926115 C330026H20Rik NCBI_Gene:100861913 MGI:1926115 lncRNA gene RIKEN cDNA C330026H20 gene
19 gene 41.009103 41.011703 negative MGI_C57BL6J_2443821 A130015J22Rik NA NA unclassified non-coding RNA gene RIKEN cDNA A130015J22 gene
19 pseudogene 41.017683 41.020295 positive MGI_C57BL6J_3782446 Gm4269 NCBI_Gene:105246575 MGI:3782446 pseudogene predicted gene 4269
19 gene 41.029275 41.059525 positive MGI_C57BL6J_98659 Dntt NCBI_Gene:21673,ENSEMBL:ENSMUSG00000025014 MGI:98659 protein coding gene deoxynucleotidyltransferase, terminal
19 gene 41.061710 41.077113 negative MGI_C57BL6J_2657025 Opalin NCBI_Gene:226115,ENSEMBL:ENSMUSG00000050121 MGI:2657025 protein coding gene oligodendrocytic myelin paranodal and inner loop protein
19 gene 41.080940 41.210848 negative MGI_C57BL6J_1346044 Tll2 NCBI_Gene:24087,ENSEMBL:ENSMUSG00000025013 MGI:1346044 protein coding gene tolloid-like 2
19 gene 41.210842 41.264004 negative MGI_C57BL6J_1914262 Tm9sf3 NCBI_Gene:107358,ENSEMBL:ENSMUSG00000025016 MGI:1914262 protein coding gene transmembrane 9 superfamily member 3
19 gene 41.259566 41.263709 negative MGI_C57BL6J_5826288 Gm46651 NCBI_Gene:108168412 MGI:5826288 lncRNA gene predicted gene, 46651
19 gene 41.264112 41.265030 positive MGI_C57BL6J_1922881 1700008F19Rik NA NA unclassified gene RIKEN cDNA 1700008F19 gene
19 gene 41.272377 41.385102 negative MGI_C57BL6J_1933177 Pik3ap1 NCBI_Gene:83490,ENSEMBL:ENSMUSG00000025017 MGI:1933177 protein coding gene phosphoinositide-3-kinase adaptor protein 1
19 gene 41.443382 41.445082 negative MGI_C57BL6J_5593110 Gm33951 NCBI_Gene:102637042 MGI:5593110 lncRNA gene predicted gene, 33951
19 pseudogene 41.459783 41.461451 positive MGI_C57BL6J_3704496 Gm9788 NCBI_Gene:100043167,ENSEMBL:ENSMUSG00000044065 MGI:3704496 pseudogene predicted pseudogene 9788
19 gene 41.481254 41.482185 negative MGI_C57BL6J_1917137 2010100M03Rik NA NA unclassified gene RIKEN cDNA 2010100M03 gene
19 gene 41.482583 41.596161 positive MGI_C57BL6J_2443930 Lcor NCBI_Gene:212391,ENSEMBL:ENSMUSG00000025019 MGI:2443930 protein coding gene ligand dependent nuclear receptor corepressor
19 gene 41.525252 41.526961 positive MGI_C57BL6J_3648734 Morf4l1b NCBI_Gene:627352 MGI:3648734 protein coding gene mortality factor 4 like 1B
19 gene 41.575867 41.589383 positive MGI_C57BL6J_2685186 Gm340 NA NA protein coding gene predicted gene 340
19 gene 41.588651 41.588789 positive MGI_C57BL6J_5530957 Mir8091 miRBase:MI0026018,NCBI_Gene:102465884,ENSEMBL:ENSMUSG00000098286 MGI:5530957 miRNA gene microRNA 8091
19 gene 41.593363 41.596158 positive MGI_C57BL6J_2147586 AI606181 NA NA protein coding gene expressed sequence AI606181
19 gene 41.597824 41.747540 negative MGI_C57BL6J_1315203 Slit1 NCBI_Gene:20562,ENSEMBL:ENSMUSG00000025020 MGI:1315203 protein coding gene slit guidance ligand 1
19 gene 41.691154 41.702436 positive MGI_C57BL6J_5593275 Gm34116 NCBI_Gene:102637251 MGI:5593275 lncRNA gene predicted gene, 34116
19 gene 41.744804 41.745053 positive MGI_C57BL6J_5452378 Gm22601 ENSEMBL:ENSMUSG00000088220 MGI:5452378 unclassified non-coding RNA gene predicted gene, 22601
19 gene 41.746961 41.750097 positive MGI_C57BL6J_5011609 Gm19424 NCBI_Gene:100502871 MGI:5011609 lncRNA gene predicted gene, 19424
19 gene 41.766588 41.802084 negative MGI_C57BL6J_1918335 Arhgap19 NCBI_Gene:71085,ENSEMBL:ENSMUSG00000025154 MGI:1918335 protein coding gene Rho GTPase activating protein 19
19 gene 41.807949 41.819642 negative MGI_C57BL6J_5624732 Gm41847 NCBI_Gene:105246576 MGI:5624732 lncRNA gene predicted gene, 41847
19 gene 41.829970 41.832583 positive MGI_C57BL6J_109450 Frat1 NCBI_Gene:14296,ENSEMBL:ENSMUSG00000067199 MGI:109450 protein coding gene frequently rearranged in advanced T cell lymphomas
19 gene 41.845972 41.848132 negative MGI_C57BL6J_2673967 Frat2 NCBI_Gene:212398,ENSEMBL:ENSMUSG00000047604 MGI:2673967 protein coding gene frequently rearranged in advanced T cell lymphomas 2
19 gene 41.862851 41.896173 negative MGI_C57BL6J_2147437 Rrp12 NCBI_Gene:107094,ENSEMBL:ENSMUSG00000035049 MGI:2147437 protein coding gene ribosomal RNA processing 12 homolog (S. cerevisiae)
19 pseudogene 41.900999 41.903231 positive MGI_C57BL6J_5826281 Gm46644 NCBI_Gene:108168404,ENSEMBL:ENSMUSG00000117675 MGI:5826281 pseudogene predicted gene, 46644
19 gene 41.911871 41.918665 positive MGI_C57BL6J_97552 Pgam1 NCBI_Gene:18648,ENSEMBL:ENSMUSG00000011752 MGI:97552 protein coding gene phosphoglycerate mutase 1
19 gene 41.919650 41.922399 positive MGI_C57BL6J_2443824 B130024M06Rik NA NA unclassified non-coding RNA gene RIKEN cDNA B130024M06 gene
19 gene 41.922292 41.933423 negative MGI_C57BL6J_1913833 Exosc1 NCBI_Gene:66583,ENSEMBL:ENSMUSG00000034321 MGI:1913833 protein coding gene exosome component 1
19 gene 41.933472 41.944104 positive MGI_C57BL6J_1921418 Zdhhc16 NCBI_Gene:74168,ENSEMBL:ENSMUSG00000025157 MGI:1921418 protein coding gene zinc finger, DHHC domain containing 16
19 gene 41.941086 41.981165 negative MGI_C57BL6J_1919449 Mms19 NCBI_Gene:72199,ENSEMBL:ENSMUSG00000025159 MGI:1919449 protein coding gene MMS19 cytosolic iron-sulfur assembly component
19 gene 41.972105 41.974522 negative MGI_C57BL6J_2443381 B130065D12Rik NA NA unclassified gene RIKEN cDNA B130065D12 gene
19 gene 41.975188 41.975286 positive MGI_C57BL6J_5452890 Gm23113 ENSEMBL:ENSMUSG00000089102 MGI:5452890 snRNA gene predicted gene, 23113
19 gene 41.981763 42.034650 positive MGI_C57BL6J_2385092 Ubtd1 NCBI_Gene:226122,ENSEMBL:ENSMUSG00000025171 MGI:2385092 protein coding gene ubiquitin domain containing 1
19 gene 41.986563 41.990400 positive MGI_C57BL6J_2443153 E130107B13Rik NA NA unclassified gene RIKEN cDNA E130107B13 gene
19 gene 42.035918 42.045111 positive MGI_C57BL6J_1861447 Ankrd2 NCBI_Gene:56642,ENSEMBL:ENSMUSG00000025172 MGI:1861447 protein coding gene ankyrin repeat domain 2 (stretch responsive muscle)
19 gene 42.045610 42.070953 positive MGI_C57BL6J_1914682 Hoga1 NCBI_Gene:67432,ENSEMBL:ENSMUSG00000025176 MGI:1914682 protein coding gene 4-hydroxy-2-oxoglutarate aldolase 1
19 gene 42.052228 42.053628 positive MGI_C57BL6J_1914015 4933411K16Rik NCBI_Gene:66765,ENSEMBL:ENSMUSG00000090369 MGI:1914015 protein coding gene RIKEN cDNA 4933411K16 gene
19 gene 42.074939 42.086370 negative MGI_C57BL6J_2449568 Morn4 NCBI_Gene:226123,ENSEMBL:ENSMUSG00000049670 MGI:2449568 protein coding gene MORN repeat containing 4
19 gene 42.090145 42.122218 positive MGI_C57BL6J_1934031 Pi4k2a NCBI_Gene:84095,ENSEMBL:ENSMUSG00000025178 MGI:1934031 protein coding gene phosphatidylinositol 4-kinase type 2 alpha
19 gene 42.123273 42.129059 negative MGI_C57BL6J_1916784 Avpi1 NCBI_Gene:69534,ENSEMBL:ENSMUSG00000018821 MGI:1916784 protein coding gene arginine vasopressin-induced 1
19 gene 42.147389 42.151703 positive MGI_C57BL6J_2147570 Marveld1 NCBI_Gene:277010,ENSEMBL:ENSMUSG00000044345 MGI:2147570 protein coding gene MARVEL (membrane-associating) domain containing 1
19 pseudogene 42.159631 42.160768 positive MGI_C57BL6J_3647230 Gm6937 NCBI_Gene:628994,ENSEMBL:ENSMUSG00000117856 MGI:3647230 pseudogene predicted pseudogene 6937
19 gene 42.163951 42.194593 positive MGI_C57BL6J_1919602 Zfyve27 NCBI_Gene:319740,ENSEMBL:ENSMUSG00000018820 MGI:1919602 protein coding gene zinc finger, FYVE domain containing 27
19 gene 42.197971 42.202252 negative MGI_C57BL6J_1860298 Sfrp5 NCBI_Gene:54612,ENSEMBL:ENSMUSG00000018822 MGI:1860298 protein coding gene secreted frizzled-related sequence protein 5
19 gene 42.247574 42.270348 positive MGI_C57BL6J_1918396 Golga7b NCBI_Gene:71146,ENSEMBL:ENSMUSG00000042532 MGI:1918396 protein coding gene golgi autoantigen, golgin subfamily a, 7B
19 gene 42.268287 42.431822 negative MGI_C57BL6J_1920082 Crtac1 NCBI_Gene:72832,ENSEMBL:ENSMUSG00000042401 MGI:1920082 protein coding gene cartilage acidic protein 1
19 gene 42.274964 42.275062 positive MGI_C57BL6J_5456116 Gm26339 ENSEMBL:ENSMUSG00000076323 MGI:5456116 miRNA gene predicted gene, 26339
19 gene 42.276887 42.314626 positive MGI_C57BL6J_5593506 Gm34347 NCBI_Gene:102637571 MGI:5593506 lncRNA gene predicted gene, 34347
19 gene 42.280082 42.280170 negative MGI_C57BL6J_4834259 Mir3085 miRBase:MI0014048,NCBI_Gene:100526549,ENSEMBL:ENSMUSG00000093234 MGI:4834259 miRNA gene microRNA 3085
19 pseudogene 42.378991 42.379101 negative MGI_C57BL6J_6302957 Gm50184 ENSEMBL:ENSMUSG00000117706 MGI:6302957 pseudogene predicted gene, 50184
19 gene 42.387741 42.397551 negative MGI_C57BL6J_5624733 Gm41848 NCBI_Gene:105246577 MGI:5624733 lncRNA gene predicted gene, 41848
19 gene 42.402212 42.414246 positive MGI_C57BL6J_5593458 Gm34299 NCBI_Gene:102637508,ENSEMBL:ENSMUSG00000117728 MGI:5593458 lncRNA gene predicted gene, 34299
19 gene 42.444057 42.448376 positive MGI_C57BL6J_5624734 Gm41849 NCBI_Gene:105246578 MGI:5624734 lncRNA gene predicted gene, 41849
19 gene 42.483124 42.486499 negative MGI_C57BL6J_5624735 Gm41850 NCBI_Gene:105246579 MGI:5624735 lncRNA gene predicted gene, 41850
19 gene 42.509119 42.512197 negative MGI_C57BL6J_5624736 Gm41851 NCBI_Gene:105246580 MGI:5624736 lncRNA gene predicted gene, 41851
19 gene 42.518315 42.592343 positive MGI_C57BL6J_1196316 R3hcc1l NCBI_Gene:52013,ENSEMBL:ENSMUSG00000025184 MGI:1196316 protein coding gene R3H domain and coiled-coil containing 1 like
19 gene 42.536850 42.563108 negative MGI_C57BL6J_4414961 Gm16541 ENSEMBL:ENSMUSG00000090117 MGI:4414961 lncRNA gene predicted gene 16541
19 gene 42.551570 42.552164 positive MGI_C57BL6J_1926126 B230214N19Rik NA NA unclassified gene RIKEN cDNA B230214N19 gene
19 gene 42.566036 42.567962 positive MGI_C57BL6J_1924199 2810404I24Rik NA NA unclassified gene RIKEN cDNA 2810404I24 gene
19 gene 42.592279 42.612813 negative MGI_C57BL6J_1914823 Loxl4 NCBI_Gene:67573,ENSEMBL:ENSMUSG00000025185 MGI:1914823 protein coding gene lysyl oxidase-like 4
19 gene 42.699777 42.699902 negative MGI_C57BL6J_5454993 Gm25216 ENSEMBL:ENSMUSG00000077768 MGI:5454993 snoRNA gene predicted gene, 25216
19 gene 42.725857 42.752824 negative MGI_C57BL6J_1921830 Pyroxd2 NCBI_Gene:74580,ENSEMBL:ENSMUSG00000060224 MGI:1921830 protein coding gene pyridine nucleotide-disulphide oxidoreductase domain 2
19 gene 42.745691 42.752329 positive MGI_C57BL6J_5011622 Gm19437 NCBI_Gene:102637646,ENSEMBL:ENSMUSG00000118354 MGI:5011622 lncRNA gene predicted gene, 19437
19 gene 42.755105 42.779996 negative MGI_C57BL6J_2177763 Hps1 NCBI_Gene:192236,ENSEMBL:ENSMUSG00000025188 MGI:2177763 protein coding gene HPS1, biogenesis of lysosomal organelles complex 3 subunit 1
19 gene 42.778653 42.781574 positive MGI_C57BL6J_3802128 Gm16244 NCBI_Gene:102637720,ENSEMBL:ENSMUSG00000090235 MGI:3802128 lncRNA gene predicted gene 16244
19 gene 42.786539 43.388455 negative MGI_C57BL6J_2685814 Hpse2 NCBI_Gene:545291,ENSEMBL:ENSMUSG00000074852 MGI:2685814 protein coding gene heparanase 2
19 gene 43.160795 43.160902 negative MGI_C57BL6J_5451912 Gm22135 ENSEMBL:ENSMUSG00000089377 MGI:5451912 rRNA gene predicted gene, 22135
19 gene 43.266936 43.277654 positive MGI_C57BL6J_5593676 Gm34517 ENSEMBL:ENSMUSG00000117880 MGI:5593676 lncRNA gene predicted gene, 34517
19 pseudogene 43.278429 43.279303 negative MGI_C57BL6J_5010564 Gm18379 NCBI_Gene:100417040,ENSEMBL:ENSMUSG00000117682 MGI:5010564 pseudogene predicted gene, 18379
19 pseudogene 43.280776 43.284225 positive MGI_C57BL6J_3647201 Gm6776 NCBI_Gene:627624,ENSEMBL:ENSMUSG00000047509 MGI:3647201 pseudogene predicted pseudogene 6776
19 gene 43.386283 43.387399 positive MGI_C57BL6J_1918806 8430434A19Rik NA NA unclassified gene RIKEN cDNA 8430434A19 gene
19 gene 43.424826 43.427960 positive MGI_C57BL6J_5621453 Gm38568 NCBI_Gene:102641642 MGI:5621453 lncRNA gene predicted gene, 38568
19 gene 43.434610 43.440460 negative MGI_C57BL6J_6097198 Gm47936 ENSEMBL:ENSMUSG00000114742 MGI:6097198 lncRNA gene predicted gene, 47936
19 gene 43.440350 43.497213 positive MGI_C57BL6J_1891366 Cnnm1 NCBI_Gene:83674,ENSEMBL:ENSMUSG00000025189 MGI:1891366 protein coding gene cyclin M1
19 gene 43.457444 43.469758 negative MGI_C57BL6J_6097201 Gm47938 ENSEMBL:ENSMUSG00000114721 MGI:6097201 lncRNA gene predicted gene, 47938
19 gene 43.499752 43.524605 negative MGI_C57BL6J_95791 Got1 NCBI_Gene:14718,ENSEMBL:ENSMUSG00000025190 MGI:95791 protein coding gene glutamic-oxaloacetic transaminase 1, soluble
19 gene 43.528312 43.566029 positive MGI_C57BL6J_6302970 Gm50194 ENSEMBL:ENSMUSG00000118221 MGI:6302970 lncRNA gene predicted gene, 50194
19 pseudogene 43.544183 43.544962 positive MGI_C57BL6J_5011364 Gm19179 NCBI_Gene:100418390,ENSEMBL:ENSMUSG00000118308 MGI:5011364 pseudogene predicted gene, 19179
19 gene 43.545927 43.573357 negative MGI_C57BL6J_5593795 Gm34636 NCBI_Gene:102637951,ENSEMBL:ENSMUSG00000117991 MGI:5593795 lncRNA gene predicted gene, 34636
19 gene 43.609077 43.610717 negative MGI_C57BL6J_5141932 Gm20467 NCBI_Gene:102638028,ENSEMBL:ENSMUSG00000092250 MGI:5141932 lncRNA gene predicted gene 20467
19 gene 43.610832 43.611890 negative MGI_C57BL6J_5826293 Gm46656 NCBI_Gene:108168417 MGI:5826293 lncRNA gene predicted gene, 46656
19 gene 43.612325 43.615892 positive MGI_C57BL6J_97348 Nkx2-3 NCBI_Gene:18089,ENSEMBL:ENSMUSG00000044220 MGI:97348 protein coding gene NK2 homeobox 3
19 gene 43.622446 43.622560 positive MGI_C57BL6J_5452423 Gm22646 ENSEMBL:ENSMUSG00000092871 MGI:5452423 miRNA gene predicted gene, 22646
19 gene 43.637372 43.642404 negative MGI_C57BL6J_3782492 Gm4311 NCBI_Gene:100043245 MGI:3782492 unclassified gene predicted gene 4311
19 gene 43.645554 43.655630 positive MGI_C57BL6J_5594081 Gm34922 NCBI_Gene:102638332,ENSEMBL:ENSMUSG00000118236 MGI:5594081 lncRNA gene predicted gene, 34922
19 gene 43.663801 43.675510 negative MGI_C57BL6J_2180509 Slc25a28 NCBI_Gene:246696,ENSEMBL:ENSMUSG00000040414 MGI:2180509 protein coding gene solute carrier family 25, member 28
19 gene 43.675178 43.677176 positive MGI_C57BL6J_2652856 BC037704 NCBI_Gene:100502982,ENSEMBL:ENSMUSG00000117698 MGI:2652856 lncRNA gene cDNA sequence BC037704
19 gene 43.689672 43.733853 positive MGI_C57BL6J_2135885 Entpd7 NCBI_Gene:93685,ENSEMBL:ENSMUSG00000025192 MGI:2135885 protein coding gene ectonucleoside triphosphate diphosphohydrolase 7
19 gene 43.733254 43.753000 negative MGI_C57BL6J_1920112 Cox15 NCBI_Gene:226139,ENSEMBL:ENSMUSG00000040018 MGI:1920112 protein coding gene cytochrome c oxidase assembly protein 15
19 gene 43.752996 43.768638 positive MGI_C57BL6J_1913638 Cutc NCBI_Gene:66388,ENSEMBL:ENSMUSG00000025193 MGI:1913638 protein coding gene cutC copper transporter
19 gene 43.782192 43.840740 positive MGI_C57BL6J_1352447 Abcc2 NCBI_Gene:12780,ENSEMBL:ENSMUSG00000025194 MGI:1352447 protein coding gene ATP-binding cassette, sub-family C (CFTR/MRP), member 2
19 gene 43.838803 43.840845 positive MGI_C57BL6J_3642139 Gm10768 NCBI_Gene:100038628 MGI:3642139 lncRNA gene predicted gene 10768
19 gene 43.846815 43.940323 negative MGI_C57BL6J_1917352 Dnmbp NCBI_Gene:71972,ENSEMBL:ENSMUSG00000025195 MGI:1917352 protein coding gene dynamin binding protein
19 gene 43.857245 43.857351 negative MGI_C57BL6J_5454177 Gm24400 ENSEMBL:ENSMUSG00000088490 MGI:5454177 snRNA gene predicted gene, 24400
19 gene 43.920473 43.927928 positive MGI_C57BL6J_6303010 Gm50217 ENSEMBL:ENSMUSG00000118000 MGI:6303010 lncRNA gene predicted gene, 50217
19 gene 43.932316 43.932432 positive MGI_C57BL6J_4421755 n-R5s21 ENSEMBL:ENSMUSG00000084641 MGI:4421755 rRNA gene nuclear encoded rRNA 5S 21
19 gene 43.940037 43.940920 positive MGI_C57BL6J_1920770 1700084K02Rik NA NA unclassified gene RIKEN cDNA 1700084K02 gene
19 gene 43.956307 43.986556 negative MGI_C57BL6J_2135874 Cpn1 NCBI_Gene:93721,ENSEMBL:ENSMUSG00000025196 MGI:2135874 protein coding gene carboxypeptidase N, polypeptide 1
19 gene 44.005022 44.029256 negative MGI_C57BL6J_1888897 Cyp2c23 NCBI_Gene:226143,ENSEMBL:ENSMUSG00000025197 MGI:1888897 protein coding gene cytochrome P450, family 2, subfamily c, polypeptide 23
19 gene 44.034943 44.070494 negative MGI_C57BL6J_2387613 Erlin1 NCBI_Gene:226144,ENSEMBL:ENSMUSG00000025198 MGI:2387613 protein coding gene ER lipid raft associated 1
19 pseudogene 44.052234 44.052736 negative MGI_C57BL6J_5010415 Gm18230 NCBI_Gene:100416753 MGI:5010415 pseudogene predicted gene, 18230
19 gene 44.073334 44.107509 negative MGI_C57BL6J_99484 Chuk NCBI_Gene:12675,ENSEMBL:ENSMUSG00000025199 MGI:99484 protein coding gene conserved helix-loop-helix ubiquitous kinase
19 gene 44.108637 44.135876 negative MGI_C57BL6J_1919752 Cwf19l1 NCBI_Gene:72502,ENSEMBL:ENSMUSG00000025200 MGI:1919752 protein coding gene CWF19-like 1, cell cycle control (S. pombe)
19 gene 44.113979 44.114124 negative MGI_C57BL6J_5454113 Gm24336 ENSEMBL:ENSMUSG00000077391 MGI:5454113 snoRNA gene predicted gene, 24336
19 gene 44.139246 44.146470 negative MGI_C57BL6J_1920939 Bloc1s2 NCBI_Gene:73689,ENSEMBL:ENSMUSG00000057506 MGI:1920939 protein coding gene biogenesis of lysosomal organelles complex-1, subunit 2
19 gene 44.147637 44.249352 negative MGI_C57BL6J_1352448 Pkd2l1 NCBI_Gene:329064,ENSEMBL:ENSMUSG00000037578 MGI:1352448 protein coding gene polycystic kidney disease 2-like 1
19 gene 44.203269 44.244016 positive MGI_C57BL6J_1353437 Scd3 NCBI_Gene:30049,ENSEMBL:ENSMUSG00000025202 MGI:1353437 protein coding gene stearoyl-coenzyme A desaturase 3
19 gene 44.225796 44.246570 negative MGI_C57BL6J_6303185 Gm50323 ENSEMBL:ENSMUSG00000117900 MGI:6303185 lncRNA gene predicted gene, 50323
19 pseudogene 44.252517 44.261446 positive MGI_C57BL6J_3643963 Gm6951 NCBI_Gene:629152,ENSEMBL:ENSMUSG00000118217 MGI:3643963 pseudogene predicted gene 6951
19 gene 44.272137 44.278228 positive MGI_C57BL6J_5594342 Gm35183 NCBI_Gene:102638677,ENSEMBL:ENSMUSG00000117958 MGI:5594342 lncRNA gene predicted gene, 35183
19 gene 44.282343 44.283697 positive MGI_C57BL6J_5624738 Gm41853 NCBI_Gene:105246582 MGI:5624738 lncRNA gene predicted gene, 41853
19 gene 44.293674 44.306864 positive MGI_C57BL6J_98240 Scd2 NCBI_Gene:20250,ENSEMBL:ENSMUSG00000025203 MGI:98240 protein coding gene stearoyl-Coenzyme A desaturase 2
19 gene 44.303171 44.303231 positive MGI_C57BL6J_4950434 Mir5114 miRBase:MI0018023,NCBI_Gene:100628619,ENSEMBL:ENSMUSG00000093315 MGI:4950434 miRNA gene microRNA 5114
19 gene 44.313772 44.317329 positive MGI_C57BL6J_6303204 Gm50334 ENSEMBL:ENSMUSG00000117957 MGI:6303204 lncRNA gene predicted gene, 50334
19 gene 44.333092 44.346743 positive MGI_C57BL6J_2670997 Scd4 NCBI_Gene:329065,ENSEMBL:ENSMUSG00000050195 MGI:2670997 protein coding gene stearoyl-coenzyme A desaturase 4
19 gene 44.394450 44.407879 negative MGI_C57BL6J_98239 Scd1 NCBI_Gene:20249,ENSEMBL:ENSMUSG00000037071 MGI:98239 protein coding gene stearoyl-Coenzyme A desaturase 1
19 gene 44.419610 44.437886 positive MGI_C57BL6J_6303210 Gm50337 ENSEMBL:ENSMUSG00000118076 MGI:6303210 lncRNA gene predicted gene, 50337
19 gene 44.453017 44.459853 positive MGI_C57BL6J_5594565 Gm35406 NCBI_Gene:102638973,ENSEMBL:ENSMUSG00000117796 MGI:5594565 lncRNA gene predicted gene, 35406
19 gene 44.493472 44.514273 positive MGI_C57BL6J_109485 Wnt8b NCBI_Gene:22423,ENSEMBL:ENSMUSG00000036961 MGI:109485 protein coding gene wingless-type MMTV integration site family, member 8B
19 gene 44.516957 44.545864 negative MGI_C57BL6J_2685187 Sec31b NCBI_Gene:240667,ENSEMBL:ENSMUSG00000051984 MGI:2685187 protein coding gene Sec31 homolog B (S. cerevisiae)
19 gene 44.543722 44.552831 negative MGI_C57BL6J_5142003 Gm20538 ENSEMBL:ENSMUSG00000091471 MGI:5142003 protein coding gene predicted gene 20538
19 gene 44.548572 44.555442 negative MGI_C57BL6J_1914514 Ndufb8 NCBI_Gene:67264,ENSEMBL:ENSMUSG00000025204 MGI:1914514 protein coding gene NADH:ubiquinone oxidoreductase subunit B8
19 gene 44.562850 44.576274 positive MGI_C57BL6J_2442345 Hif1an NCBI_Gene:319594,ENSEMBL:ENSMUSG00000036450 MGI:2442345 protein coding gene hypoxia-inducible factor 1, alpha subunit inhibitor
19 gene 44.614740 44.646879 positive MGI_C57BL6J_5594619 Gm35460 NCBI_Gene:102639056,ENSEMBL:ENSMUSG00000117911 MGI:5594619 lncRNA gene predicted gene, 35460
19 gene 44.672417 44.674865 positive MGI_C57BL6J_5624739 Gm41854 NCBI_Gene:105246583 MGI:5624739 lncRNA gene predicted gene, 41854
19 gene 44.685753 44.695460 negative MGI_C57BL6J_5477138 Gm26644 NCBI_Gene:102639186,ENSEMBL:ENSMUSG00000097683 MGI:5477138 lncRNA gene predicted gene, 26644
19 gene 44.739879 44.743444 positive MGI_C57BL6J_5594769 Gm35610 NCBI_Gene:102639257,ENSEMBL:ENSMUSG00000117823 MGI:5594769 lncRNA gene predicted gene, 35610
19 gene 44.745693 44.837871 positive MGI_C57BL6J_97486 Pax2 NCBI_Gene:18504,ENSEMBL:ENSMUSG00000004231 MGI:97486 protein coding gene paired box 2
19 gene 44.773762 44.784512 negative MGI_C57BL6J_5141860 Gm20395 ENSEMBL:ENSMUSG00000092469 MGI:5141860 lncRNA gene predicted gene 20395
19 gene 44.808406 44.808529 positive MGI_C57BL6J_5530731 Mir6405 miRBase:MI0021941,NCBI_Gene:102466645,ENSEMBL:ENSMUSG00000098952 MGI:5530731 miRNA gene microRNA 6405
19 gene 44.828493 44.835938 negative MGI_C57BL6J_1920572 1700039E22Rik NCBI_Gene:73322,ENSEMBL:ENSMUSG00000092369 MGI:1920572 lncRNA gene RIKEN cDNA 1700039E22 gene
19 pseudogene 44.851009 44.851979 positive MGI_C57BL6J_3646252 Gm5246 NCBI_Gene:383450,ENSEMBL:ENSMUSG00000117967 MGI:3646252 pseudogene predicted gene 5246
19 gene 44.918505 44.983787 positive MGI_C57BL6J_1924968 Slf2 NCBI_Gene:226151,ENSEMBL:ENSMUSG00000036097 MGI:1924968 protein coding gene SMC5-SMC6 complex localization factor 2
19 gene 44.945022 44.945128 positive MGI_C57BL6J_5455259 Gm25482 ENSEMBL:ENSMUSG00000065159 MGI:5455259 snRNA gene predicted gene, 25482
19 gene 44.960373 44.984550 negative MGI_C57BL6J_1921144 4930414N06Rik NCBI_Gene:73894,ENSEMBL:ENSMUSG00000118204 MGI:1921144 lncRNA gene RIKEN cDNA 4930414N06 gene
19 gene 44.988966 45.003397 positive MGI_C57BL6J_1347047 Sema4g NCBI_Gene:26456,ENSEMBL:ENSMUSG00000025207 MGI:1347047 protein coding gene sema domain, immunoglobulin domain (Ig), transmembrane domain (TM) and short cytoplasmic domain, (semaphorin) 4G
19 gene 45.004829 45.006442 negative MGI_C57BL6J_2137229 Mrpl43 NCBI_Gene:94067,ENSEMBL:ENSMUSG00000025208 MGI:2137229 protein coding gene mitochondrial ribosomal protein L43
19 gene 45.005662 45.012763 positive MGI_C57BL6J_2137410 Twnk NCBI_Gene:226153,ENSEMBL:ENSMUSG00000025209 MGI:2137410 protein coding gene twinkle mtDNA helicase
19 gene 45.014414 45.027115 positive MGI_C57BL6J_2385095 Lzts2 NCBI_Gene:226154,ENSEMBL:ENSMUSG00000035342 MGI:2385095 protein coding gene leucine zipper, putative tumor suppressor 2
19 gene 45.026906 45.058307 negative MGI_C57BL6J_3608325 Pdzd7 NCBI_Gene:100503041,ENSEMBL:ENSMUSG00000074818 MGI:3608325 protein coding gene PDZ domain containing 7
19 gene 45.030404 45.031132 positive MGI_C57BL6J_1924586 9430030N17Rik NA NA unclassified gene RIKEN cDNA 9430030N17 gene
19 gene 45.047241 45.056383 positive MGI_C57BL6J_2137679 Sfxn3 NCBI_Gene:94280,ENSEMBL:ENSMUSG00000025212 MGI:2137679 protein coding gene sideroflexin 3
19 gene 45.058841 45.110342 positive MGI_C57BL6J_5595026 Gm35867 NCBI_Gene:102639590,ENSEMBL:ENSMUSG00000117848 MGI:5595026 lncRNA gene predicted gene, 35867
19 gene 45.060632 45.075109 negative MGI_C57BL6J_5594941 Gm35782 NCBI_Gene:102639478 MGI:5594941 lncRNA gene predicted gene, 35782
19 gene 45.075091 45.079289 positive MGI_C57BL6J_2147606 Kazald1 NCBI_Gene:107250,ENSEMBL:ENSMUSG00000025213 MGI:2147606 protein coding gene Kazal-type serine peptidase inhibitor domain 1
19 gene 45.080008 45.080583 positive MGI_C57BL6J_1922558 4930557B21Rik NA NA unclassified gene RIKEN cDNA 4930557B21 gene
19 gene 45.144743 45.146954 negative MGI_C57BL6J_5595082 Gm35923 NCBI_Gene:102639665 MGI:5595082 lncRNA gene predicted gene, 35923
19 gene 45.150082 45.156943 positive MGI_C57BL6J_98769 Tlx1 NCBI_Gene:21908,ENSEMBL:ENSMUSG00000025215 MGI:98769 protein coding gene T cell leukemia, homeobox 1
19 gene 45.154057 45.159304 negative MGI_C57BL6J_5141889 Tlx1os ENSEMBL:ENSMUSG00000092346 MGI:5141889 antisense lncRNA gene T cell leukemia, homeobox 1, opposite strand
19 gene 45.232684 45.237430 negative MGI_C57BL6J_104867 Lbx1 NCBI_Gene:16814,ENSEMBL:ENSMUSG00000025216 MGI:104867 protein coding gene ladybird homeobox 1
19 gene 45.300455 45.338477 negative MGI_C57BL6J_5579284 Gm28578 NCBI_Gene:102639970,NCBI_Gene:102640042,ENSEMBL:ENSMUSG00000100417 MGI:5579284 lncRNA gene predicted gene 28578
19 gene 45.300458 45.303246 negative MGI_C57BL6J_5580301 Gm29595 NCBI_Gene:102639746 MGI:5580301 lncRNA gene predicted gene 29595
19 gene 45.311291 45.312882 negative MGI_C57BL6J_5580299 Gm29593 NCBI_Gene:108168425 MGI:5580299 lncRNA gene predicted gene 29593
19 gene 45.317893 45.318429 positive MGI_C57BL6J_5580300 Gm29594 ENSEMBL:ENSMUSG00000102057 MGI:5580300 lncRNA gene predicted gene 29594
19 gene 45.363213 45.363649 negative MGI_C57BL6J_1922903 1700016H03Rik ENSEMBL:ENSMUSG00000114673 MGI:1922903 lncRNA gene RIKEN cDNA 1700016H03 gene
19 gene 45.363734 45.533343 positive MGI_C57BL6J_1338871 Btrc NCBI_Gene:12234,ENSEMBL:ENSMUSG00000025217 MGI:1338871 protein coding gene beta-transducin repeat containing protein
19 pseudogene 45.396765 45.397796 negative MGI_C57BL6J_5010289 Gm18104 NCBI_Gene:100416415 MGI:5010289 pseudogene predicted gene, 18104
19 pseudogene 45.450276 45.451247 negative MGI_C57BL6J_3649145 Gm6807 NCBI_Gene:627889,ENSEMBL:ENSMUSG00000057605 MGI:3649145 pseudogene predicted gene 6807
19 gene 45.542766 45.544997 negative MGI_C57BL6J_5624741 Gm41856 NCBI_Gene:105246585 MGI:5624741 lncRNA gene predicted gene, 41856
19 gene 45.544596 45.546346 positive MGI_C57BL6J_5011824 Gm19639 NCBI_Gene:100503332 MGI:5011824 lncRNA gene predicted gene, 19639
19 gene 45.552275 45.560543 negative MGI_C57BL6J_1889000 Poll NCBI_Gene:56626,ENSEMBL:ENSMUSG00000025218 MGI:1889000 protein coding gene polymerase (DNA directed), lambda
19 gene 45.560590 45.578287 positive MGI_C57BL6J_1924407 Dpcd NCBI_Gene:226162 MGI:1924407 protein coding gene deleted in primary ciliary dyskinesia
19 gene 45.560615 45.579763 positive MGI_C57BL6J_4820566 Gm17018 ENSEMBL:ENSMUSG00000041035 MGI:4820566 protein coding gene predicted gene 17018
19 gene 45.578254 45.660539 negative MGI_C57BL6J_1354698 Fbxw4 NCBI_Gene:30838,ENSEMBL:ENSMUSG00000040913 MGI:1354698 protein coding gene F-box and WD-40 domain protein 4
19 gene 45.726555 45.730558 negative MGI_C57BL6J_1918482 4933429K18Rik NCBI_Gene:71232 MGI:1918482 lncRNA gene RIKEN cDNA 4933429K18 gene
19 gene 45.736798 45.742938 negative MGI_C57BL6J_99604 Fgf8 NCBI_Gene:14179,ENSEMBL:ENSMUSG00000025219 MGI:99604 protein coding gene fibroblast growth factor 8
19 gene 45.747734 45.749591 negative MGI_C57BL6J_894653 Npm3 NCBI_Gene:18150,ENSEMBL:ENSMUSG00000056209 MGI:894653 protein coding gene nucleoplasmin 3
19 gene 45.749508 45.752310 positive MGI_C57BL6J_3782937 Gm15491 ENSEMBL:ENSMUSG00000087367 MGI:3782937 lncRNA gene predicted gene 15491
19 gene 45.750259 45.783837 negative MGI_C57BL6J_1932139 Oga NCBI_Gene:76055,ENSEMBL:ENSMUSG00000025220 MGI:1932139 protein coding gene O-GlcNAcase
19 gene 45.791839 45.816432 negative MGI_C57BL6J_2135916 Kcnip2 NCBI_Gene:80906,ENSEMBL:ENSMUSG00000025221 MGI:2135916 protein coding gene Kv channel-interacting protein 2
19 gene 45.817364 45.998580 negative MGI_C57BL6J_1918867 Armh3 NCBI_Gene:71617,ENSEMBL:ENSMUSG00000039901 MGI:1918867 protein coding gene armadillo-like helical domain containing 3
19 gene 45.843617 45.848296 positive MGI_C57BL6J_6302974 Gm50196 ENSEMBL:ENSMUSG00000117956 MGI:6302974 lncRNA gene predicted gene, 50196
19 pseudogene 45.877611 45.878164 negative MGI_C57BL6J_3645759 Gm6813 NCBI_Gene:627939,ENSEMBL:ENSMUSG00000117972 MGI:3645759 pseudogene predicted gene 6813
19 gene 45.997572 46.013387 positive MGI_C57BL6J_1922306 4930505N22Rik NCBI_Gene:100174921,ENSEMBL:ENSMUSG00000097690 MGI:1922306 lncRNA gene RIKEN cDNA 4930505N22 gene
19 gene 46.003478 46.006173 positive MGI_C57BL6J_2181763 Hps6 NCBI_Gene:20170,ENSEMBL:ENSMUSG00000074811 MGI:2181763 protein coding gene HPS6, biogenesis of lysosomal organelles complex 2 subunit 3
19 gene 46.031570 46.045515 negative MGI_C57BL6J_894762 Ldb1 NCBI_Gene:16825,ENSEMBL:ENSMUSG00000025223 MGI:894762 protein coding gene LIM domain binding 1
19 gene 46.044886 46.072915 positive MGI_C57BL6J_2385096 Pprc1 NCBI_Gene:226169,ENSEMBL:ENSMUSG00000055491 MGI:2385096 protein coding gene peroxisome proliferative activated receptor, gamma, coactivator-related 1
19 gene 46.075847 46.085543 positive MGI_C57BL6J_1918019 Nolc1 NCBI_Gene:70769,ENSEMBL:ENSMUSG00000015176 MGI:1918019 protein coding gene nucleolar and coiled-body phosphoprotein 1
19 gene 46.124930 46.131471 positive MGI_C57BL6J_6303157 Gm50306 ENSEMBL:ENSMUSG00000117703 MGI:6303157 lncRNA gene predicted gene, 50306
19 gene 46.131897 46.135694 positive MGI_C57BL6J_1195976 Elovl3 NCBI_Gene:12686,ENSEMBL:ENSMUSG00000038754 MGI:1195976 protein coding gene elongation of very long chain fatty acids (FEN1/Elo2, SUR4/Elo3, yeast)-like 3
19 gene 46.135294 46.148326 negative MGI_C57BL6J_1100498 Pitx3 NCBI_Gene:18742,ENSEMBL:ENSMUSG00000025229 MGI:1100498 protein coding gene paired-like homeodomain transcription factor 3
19 gene 46.152509 46.286510 positive MGI_C57BL6J_1861607 Gbf1 NCBI_Gene:107338,ENSEMBL:ENSMUSG00000025224 MGI:1861607 protein coding gene golgi-specific brefeldin A-resistance factor 1
19 gene 46.180483 46.185809 positive MGI_C57BL6J_2444071 D430033H22Rik NA NA unclassified gene RIKEN cDNA D430033H22 gene
19 pseudogene 46.204141 46.205964 negative MGI_C57BL6J_3648532 Gm8974 NCBI_Gene:105246586,ENSEMBL:ENSMUSG00000093525 MGI:3648532 pseudogene predicted gene 8974
19 gene 46.213099 46.215985 positive MGI_C57BL6J_2443201 C130013I19Rik NA NA unclassified gene RIKEN cDNA C130013I19 gene
19 gene 46.264539 46.267669 negative MGI_C57BL6J_4439650 Gm16726 ENSEMBL:ENSMUSG00000086816 MGI:4439650 lncRNA gene predicted gene, 16726
19 gene 46.303590 46.305623 negative MGI_C57BL6J_2147599 4833438C02Rik NCBI_Gene:100503392,ENSEMBL:ENSMUSG00000118087 MGI:2147599 lncRNA gene RIKEN cDNA 4833438C02 gene
19 gene 46.304320 46.312385 positive MGI_C57BL6J_1099800 Nfkb2 NCBI_Gene:18034,ENSEMBL:ENSMUSG00000025225 MGI:1099800 protein coding gene nuclear factor of kappa light polypeptide gene enhancer in B cells 2, p49/p100
19 gene 46.312085 46.327188 negative MGI_C57BL6J_1920978 Psd NCBI_Gene:73728,ENSEMBL:ENSMUSG00000037126 MGI:1920978 protein coding gene pleckstrin and Sec7 domain containing
19 gene 46.328119 46.330446 positive MGI_C57BL6J_1915681 Fbxl15 NCBI_Gene:68431,ENSEMBL:ENSMUSG00000025226 MGI:1915681 protein coding gene F-box and leucine-rich repeat protein 15
19 gene 46.329812 46.338702 negative MGI_C57BL6J_1914366 Cuedc2 NCBI_Gene:67116,ENSEMBL:ENSMUSG00000036748 MGI:1914366 protein coding gene CUE domain containing 2
19 gene 46.335287 46.338538 positive MGI_C57BL6J_5477286 Gm26792 ENSEMBL:ENSMUSG00000096996 MGI:5477286 lncRNA gene predicted gene, 26792
19 gene 46.338776 46.344131 positive MGI_C57BL6J_5595652 Gm36493 NCBI_Gene:102640430 MGI:5595652 lncRNA gene predicted gene, 36493
19 gene 46.341121 46.375254 positive MGI_C57BL6J_1922396 Mfsd13a NCBI_Gene:75146,ENSEMBL:ENSMUSG00000025227 MGI:1922396 protein coding gene major facilitator superfamily domain containing 13a
19 gene 46.342762 46.342870 positive MGI_C57BL6J_3629945 Mir146b miRBase:MI0004665,NCBI_Gene:751550,ENSEMBL:ENSMUSG00000070127 MGI:3629945 miRNA gene microRNA 146b
19 gene 46.348201 46.350302 negative MGI_C57BL6J_1922829 2310034G01Rik NCBI_Gene:75579,ENSEMBL:ENSMUSG00000099655 MGI:1922829 lncRNA gene RIKEN cDNA 2310034G01 gene
19 gene 46.359036 46.359144 positive MGI_C57BL6J_5454387 Gm24610 ENSEMBL:ENSMUSG00000065204 MGI:5454387 snoRNA gene predicted gene, 24610
19 gene 46.376811 46.395748 negative MGI_C57BL6J_1858964 Actr1a NCBI_Gene:54130,ENSEMBL:ENSMUSG00000025228 MGI:1858964 protein coding gene ARP1 actin-related protein 1A, centractin alpha
19 gene 46.396896 46.488804 positive MGI_C57BL6J_1345643 Sufu NCBI_Gene:24069,ENSEMBL:ENSMUSG00000025231 MGI:1345643 protein coding gene SUFU negative regulator of hedgehog signaling
19 gene 46.426855 46.427656 positive MGI_C57BL6J_1924501 9430020M11Rik NA NA unclassified gene RIKEN cDNA 9430020M11 gene
19 gene 46.501648 46.502782 negative MGI_C57BL6J_3704497 Gm9798 NA NA unclassified gene predicted gene 9798
19 gene 46.501648 46.516848 positive MGI_C57BL6J_1933302 Trim8 NCBI_Gene:93679,ENSEMBL:ENSMUSG00000025034 MGI:1933302 protein coding gene tripartite motif-containing 8
19 gene 46.531096 46.573198 negative MGI_C57BL6J_1929699 Arl3 NCBI_Gene:56350,ENSEMBL:ENSMUSG00000025035 MGI:1929699 protein coding gene ADP-ribosylation factor-like 3
19 gene 46.573323 46.598066 positive MGI_C57BL6J_2137678 Sfxn2 NCBI_Gene:94279,ENSEMBL:ENSMUSG00000025036 MGI:2137678 protein coding gene sideroflexin 2
19 gene 46.599084 46.657389 positive MGI_C57BL6J_107577 Wbp1l NCBI_Gene:226178,ENSEMBL:ENSMUSG00000047731 MGI:107577 protein coding gene WW domain binding protein 1 like
19 gene 46.657734 46.666450 negative MGI_C57BL6J_5595761 Gm36602 NCBI_Gene:102640568,ENSEMBL:ENSMUSG00000118040 MGI:5595761 lncRNA gene predicted gene, 36602
19 gene 46.667165 46.673172 negative MGI_C57BL6J_88586 Cyp17a1 NCBI_Gene:13074,ENSEMBL:ENSMUSG00000003555 MGI:88586 protein coding gene cytochrome P450, family 17, subfamily a, polypeptide 1
19 gene 46.668680 46.676083 positive MGI_C57BL6J_5624742 Gm41857 NCBI_Gene:105246587 MGI:5624742 lncRNA gene predicted gene, 41857
19 pseudogene 46.674086 46.675297 negative MGI_C57BL6J_3648147 Gm6967 NCBI_Gene:629359,ENSEMBL:ENSMUSG00000097937 MGI:3648147 pseudogene predicted gene 6967
19 gene 46.689906 46.703382 positive MGI_C57BL6J_1913689 Borcs7 NCBI_Gene:66439,ENSEMBL:ENSMUSG00000062376 MGI:1913689 protein coding gene BLOC-1 related complex subunit 7
19 gene 46.707359 46.741099 positive MGI_C57BL6J_1929882 As3mt NCBI_Gene:57344,ENSEMBL:ENSMUSG00000003559 MGI:1929882 protein coding gene arsenic (+3 oxidation state) methyltransferase
19 gene 46.759671 46.763467 negative MGI_C57BL6J_3704498 Gm10199 NA NA unclassified gene predicted gene 10199
19 gene 46.761564 46.880192 positive MGI_C57BL6J_2151054 Cnnm2 NCBI_Gene:94219,ENSEMBL:ENSMUSG00000064105 MGI:2151054 protein coding gene cyclin M2
19 gene 46.881495 46.883439 positive MGI_C57BL6J_6303362 Gm50431 ENSEMBL:ENSMUSG00000117814 MGI:6303362 lncRNA gene predicted gene, 50431
19 gene 46.883090 46.883430 negative MGI_C57BL6J_1925220 A930026I22Rik NA NA unclassified gene RIKEN cDNA A930026I22 gene
19 gene 46.883317 47.015189 negative MGI_C57BL6J_2178563 Nt5c2 NCBI_Gene:76952,ENSEMBL:ENSMUSG00000025041 MGI:2178563 protein coding gene 5’-nucleotidase, cytosolic II
19 gene 46.889008 46.909575 positive MGI_C57BL6J_3704499 Gm9751 NA NA unclassified gene predicted gene 9751
19 pseudogene 46.920507 46.921270 negative MGI_C57BL6J_5010675 Gm18490 NCBI_Gene:100417264 MGI:5010675 pseudogene predicted gene, 18490
19 pseudogene 46.996290 46.997196 positive MGI_C57BL6J_5010842 Gm18657 NCBI_Gene:100417509 MGI:5010842 pseudogene predicted gene, 18657
19 gene 47.014698 47.025327 positive MGI_C57BL6J_96568 Ina NCBI_Gene:226180,ENSEMBL:ENSMUSG00000034336 MGI:96568 protein coding gene internexin neuronal intermediate filament protein, alpha
19 gene 47.033617 47.051096 negative MGI_C57BL6J_1918291 Pcgf6 NCBI_Gene:71041,ENSEMBL:ENSMUSG00000025050 MGI:1918291 protein coding gene polycomb group ring finger 6
19 pseudogene 47.054505 47.055248 negative MGI_C57BL6J_6303179 Gm50319 ENSEMBL:ENSMUSG00000117691 MGI:6303179 pseudogene predicted gene, 50319
19 gene 47.058162 47.058268 positive MGI_C57BL6J_5452917 Gm23140 ENSEMBL:ENSMUSG00000094400 MGI:5452917 snRNA gene predicted gene, 23140
19 gene 47.067746 47.083479 positive MGI_C57BL6J_2442144 Taf5 NCBI_Gene:226182,ENSEMBL:ENSMUSG00000025049 MGI:2442144 protein coding gene TATA-box binding protein associated factor 5
19 gene 47.083464 47.090647 negative MGI_C57BL6J_1891435 Atp5md NCBI_Gene:66477,ENSEMBL:ENSMUSG00000071528 MGI:1891435 protein coding gene ATP synthase membrane subunit DAPIT
19 gene 47.090749 47.131865 positive MGI_C57BL6J_1341788 Pdcd11 NCBI_Gene:18572,ENSEMBL:ENSMUSG00000025047 MGI:1341788 protein coding gene programmed cell death 11
19 gene 47.105353 47.138294 negative MGI_C57BL6J_1919941 Calhm2 NCBI_Gene:72691,ENSEMBL:ENSMUSG00000033033 MGI:1919941 protein coding gene calcium homeostasis modulator family member 2
19 gene 47.126150 47.131251 negative MGI_C57BL6J_3704500 D930027P08Rik NA NA unclassified gene RIKEN cDNA D930027P08 gene
19 gene 47.140909 47.144254 negative MGI_C57BL6J_3643383 Calhm1 NCBI_Gene:546729,ENSEMBL:ENSMUSG00000079258 MGI:3643383 protein coding gene calcium homeostasis modulator 1
19 gene 47.151609 47.157764 negative MGI_C57BL6J_3645665 Calhm3 NCBI_Gene:240669,ENSEMBL:ENSMUSG00000094219 MGI:3645665 protein coding gene calcium homeostasis modulator 3
19 pseudogene 47.170426 47.171200 negative MGI_C57BL6J_3645322 H1f11-ps NCBI_Gene:629389,ENSEMBL:ENSMUSG00000091230 MGI:3645322 pseudogene H1.11 linker histone, pseudogene
19 gene 47.178820 47.259441 positive MGI_C57BL6J_1334263 Neurl1a NCBI_Gene:18011,ENSEMBL:ENSMUSG00000006435 MGI:1334263 protein coding gene neuralized E3 ubiquitin protein ligase 1A
19 gene 47.197881 47.206768 negative MGI_C57BL6J_5595852 Gm36693 NCBI_Gene:102640681,ENSEMBL:ENSMUSG00000118127 MGI:5595852 lncRNA gene predicted gene, 36693
19 gene 47.220713 47.221909 negative MGI_C57BL6J_6303214 Gm50339 ENSEMBL:ENSMUSG00000117659 MGI:6303214 lncRNA gene predicted gene, 50339
19 gene 47.260174 47.464613 negative MGI_C57BL6J_1298393 Sh3pxd2a NCBI_Gene:14218,ENSEMBL:ENSMUSG00000053617 MGI:1298393 protein coding gene SH3 and PX domains 2A
19 gene 47.273519 47.273589 negative MGI_C57BL6J_5530958 Mir6995 miRBase:MI0022843,NCBI_Gene:102466782,ENSEMBL:ENSMUSG00000098786 MGI:5530958 miRNA gene microRNA 6995
19 gene 47.286725 47.293330 positive MGI_C57BL6J_5588993 Gm29834 NCBI_Gene:102631515 MGI:5588993 lncRNA gene predicted gene, 29834
19 gene 47.426070 47.435135 positive MGI_C57BL6J_5596044 Gm36885 NCBI_Gene:102640939 MGI:5596044 lncRNA gene predicted gene, 36885
19 gene 47.483840 47.485344 negative MGI_C57BL6J_5624743 Gm41858 NCBI_Gene:105246588 MGI:5624743 lncRNA gene predicted gene, 41858
19 gene 47.501033 47.537507 negative MGI_C57BL6J_1915581 Stn1 NCBI_Gene:108689,ENSEMBL:ENSMUSG00000042694 MGI:1915581 protein coding gene STN1, CST complex subunit
19 gene 47.512982 47.516578 positive MGI_C57BL6J_5011742 Gm19557 NCBI_Gene:100503104,ENSEMBL:ENSMUSG00000097990 MGI:5011742 lncRNA gene predicted gene, 19557
19 gene 47.579678 47.645246 positive MGI_C57BL6J_103241 Slk NCBI_Gene:20874,ENSEMBL:ENSMUSG00000025060 MGI:103241 protein coding gene STE20-like kinase
19 gene 47.597237 47.602329 negative MGI_C57BL6J_6303244 Gm50358 ENSEMBL:ENSMUSG00000118206 MGI:6303244 lncRNA gene predicted gene, 50358
19 gene 47.605899 47.617106 negative MGI_C57BL6J_3802005 Gm16068 NCBI_Gene:102631588,ENSEMBL:ENSMUSG00000086121 MGI:3802005 lncRNA gene predicted gene 16068
19 gene 47.646341 47.692094 negative MGI_C57BL6J_88450 Col17a1 NCBI_Gene:12821,ENSEMBL:ENSMUSG00000025064 MGI:88450 protein coding gene collagen, type XVII, alpha 1
19 gene 47.694671 47.696533 negative MGI_C57BL6J_6303115 Gm50281 ENSEMBL:ENSMUSG00000117702 MGI:6303115 lncRNA gene predicted gene, 50281
19 gene 47.710866 47.710981 positive MGI_C57BL6J_5455862 Gm26085 ENSEMBL:ENSMUSG00000088525 MGI:5455862 snoRNA gene predicted gene, 26085
19 gene 47.714784 47.714887 negative MGI_C57BL6J_5454582 Gm24805 ENSEMBL:ENSMUSG00000096704 MGI:5454582 snRNA gene predicted gene, 24805
19 gene 47.721035 47.723066 positive MGI_C57BL6J_6303117 Gm50282 ENSEMBL:ENSMUSG00000118149 MGI:6303117 lncRNA gene predicted gene, 50282
19 gene 47.731682 47.735588 positive MGI_C57BL6J_1915038 Sfr1 NCBI_Gene:67788,ENSEMBL:ENSMUSG00000025066 MGI:1915038 protein coding gene SWI5 dependent recombination repair 1
19 gene 47.735267 47.919287 negative MGI_C57BL6J_1289258 Cfap43 NCBI_Gene:100048534,ENSEMBL:ENSMUSG00000044948 MGI:1289258 protein coding gene cilia and flagella associated protein 43
19 gene 47.755022 47.755157 negative MGI_C57BL6J_5531244 Mir8090 miRBase:MI0026017,NCBI_Gene:102465883,ENSEMBL:ENSMUSG00000099069 MGI:5531244 miRNA gene microRNA 8090
19 gene 47.853111 47.854772 negative MGI_C57BL6J_5589180 Gm30021 NCBI_Gene:102631766 MGI:5589180 lncRNA gene predicted gene, 30021
19 gene 47.854970 47.864790 positive MGI_C57BL6J_1342273 Gsto1 NCBI_Gene:14873,ENSEMBL:ENSMUSG00000025068 MGI:1342273 protein coding gene glutathione S-transferase omega 1
19 gene 47.865534 47.886324 positive MGI_C57BL6J_1915464 Gsto2 NCBI_Gene:68214,ENSEMBL:ENSMUSG00000025069 MGI:1915464 protein coding gene glutathione S-transferase omega 2
19 gene 47.894593 47.919519 negative MGI_C57BL6J_3042776 Itprip NCBI_Gene:414801,ENSEMBL:ENSMUSG00000117975 MGI:3042776 protein coding gene inositol 1,4,5-triphosphate receptor interacting protein
19 gene 47.919192 47.919273 negative MGI_C57BL6J_5452017 Gm22240 ENSEMBL:ENSMUSG00000092966 MGI:5452017 miRNA gene predicted gene, 22240
19 gene 47.937675 48.035387 positive MGI_C57BL6J_2685815 Cfap58 NCBI_Gene:381229,ENSEMBL:ENSMUSG00000046585 MGI:2685815 protein coding gene cilia and flagella associated protein 58
19 gene 48.117348 48.136082 positive MGI_C57BL6J_6303360 Gm50430 ENSEMBL:ENSMUSG00000117690 MGI:6303360 lncRNA gene predicted gene, 50430
19 gene 48.206025 48.805505 positive MGI_C57BL6J_1913923 Sorcs3 NCBI_Gene:66673,ENSEMBL:ENSMUSG00000063434 MGI:1913923 protein coding gene sortilin-related VPS10 domain containing receptor 3
19 gene 48.240535 48.240645 negative MGI_C57BL6J_5453634 Gm23857 ENSEMBL:ENSMUSG00000089004 MGI:5453634 rRNA gene predicted gene, 23857
19 gene 48.240774 48.241114 negative MGI_C57BL6J_1924179 1700021N20Rik NA NA unclassified gene RIKEN cDNA 1700021N20 gene
19 gene 48.811136 48.813495 positive MGI_C57BL6J_6303368 Gm50436 ENSEMBL:ENSMUSG00000117930 MGI:6303368 unclassified gene predicted gene, 50436
19 gene 48.990469 48.991981 negative MGI_C57BL6J_1922433 4930535F04Rik ENSEMBL:ENSMUSG00000118014 MGI:1922433 unclassified gene RIKEN cDNA 4930535F04 gene
19 gene 48.992084 48.996546 positive MGI_C57BL6J_6303375 Gm50441 ENSEMBL:ENSMUSG00000117996 MGI:6303375 lncRNA gene predicted gene, 50441
19 gene 49.090673 49.107771 positive MGI_C57BL6J_6303377 Gm50442 ENSEMBL:ENSMUSG00000118111 MGI:6303377 lncRNA gene predicted gene, 50442
19 pseudogene 49.554018 49.557406 positive MGI_C57BL6J_6303380 Gm50444 ENSEMBL:ENSMUSG00000117931 MGI:6303380 pseudogene predicted gene, 50444
19 pseudogene 49.709393 49.710153 negative MGI_C57BL6J_3644403 Gm6975 NCBI_Gene:629448,ENSEMBL:ENSMUSG00000118059 MGI:3644403 pseudogene predicted gene 6975
19 gene 49.709794 49.709872 negative MGI_C57BL6J_5531317 Gm27935 ENSEMBL:ENSMUSG00000098507 MGI:5531317 miRNA gene predicted gene, 27935
19 pseudogene 49.868272 49.870143 positive MGI_C57BL6J_108066 Siah1-ps1 NCBI_Gene:20435,ENSEMBL:ENSMUSG00000117697 MGI:108066 pseudogene siah E3 ubiquitin protein ligase 1, pseudogene 1
19 pseudogene 50.030100 50.030756 negative MGI_C57BL6J_3648883 Rpl13a-ps1 NCBI_Gene:433251,ENSEMBL:ENSMUSG00000062083 MGI:3648883 pseudogene ribosomal protein 13A, pseudogene 1
19 gene 50.143295 50.679136 negative MGI_C57BL6J_1929666 Sorcs1 NCBI_Gene:58178,ENSEMBL:ENSMUSG00000043531 MGI:1929666 protein coding gene sortilin-related VPS10 domain containing receptor 1
19 gene 50.144491 50.144615 positive MGI_C57BL6J_5531131 Gm27749 ENSEMBL:ENSMUSG00000098916 MGI:5531131 miRNA gene predicted gene, 27749
19 gene 50.146938 50.180652 positive MGI_C57BL6J_5791188 Gm45352 ENSEMBL:ENSMUSG00000110007 MGI:5791188 lncRNA gene predicted gene 45352
19 gene 50.327639 50.331581 positive MGI_C57BL6J_5589282 Gm30123 NA NA lncRNA gene predicted gene%2c 30123
19 gene 50.665964 50.778662 positive MGI_C57BL6J_5477123 Gm26629 NCBI_Gene:102631841,ENSEMBL:ENSMUSG00000097446 MGI:5477123 lncRNA gene predicted gene, 26629
19 gene 50.705722 50.713685 negative MGI_C57BL6J_6303151 Gm50302 ENSEMBL:ENSMUSG00000117758 MGI:6303151 lncRNA gene predicted gene, 50302
19 gene 50.812324 50.812360 positive MGI_C57BL6J_5455436 Gm25659 ENSEMBL:ENSMUSG00000089094 MGI:5455436 rRNA gene predicted gene, 25659
19 gene 51.144749 51.148034 positive MGI_C57BL6J_6303175 Gm50317 ENSEMBL:ENSMUSG00000118338 MGI:6303175 unclassified gene predicted gene, 50317
19 gene 51.239690 51.239796 negative MGI_C57BL6J_5455421 Gm25644 ENSEMBL:ENSMUSG00000065143 MGI:5455421 snRNA gene predicted gene, 25644
19 pseudogene 51.631549 51.632627 positive MGI_C57BL6J_6303189 Gm50325 ENSEMBL:ENSMUSG00000117806 MGI:6303189 pseudogene predicted gene, 50325
19 pseudogene 51.674388 51.674650 negative MGI_C57BL6J_6303190 Gm50326 ENSEMBL:ENSMUSG00000118158 MGI:6303190 pseudogene predicted gene, 50326
19 pseudogene 51.792226 51.792633 positive MGI_C57BL6J_3644718 Rpl31-ps18 NCBI_Gene:668536,ENSEMBL:ENSMUSG00000097719 MGI:3644718 pseudogene ribosomal protein L31, pseudogene 18
19 gene 51.891724 51.920333 negative MGI_C57BL6J_6303196 Gm50330 ENSEMBL:ENSMUSG00000117867 MGI:6303196 lncRNA gene predicted gene, 50330
19 gene 51.913963 51.984533 positive MGI_C57BL6J_6303194 Gm50329 ENSEMBL:ENSMUSG00000118173 MGI:6303194 lncRNA gene predicted gene, 50329
19 pseudogene 51.972994 51.974073 negative MGI_C57BL6J_3782291 Gm4115 NCBI_Gene:100042936 MGI:3782291 pseudogene predicted gene 4115
19 gene 52.264297 52.265476 positive MGI_C57BL6J_96572 Ins1 NCBI_Gene:16333,ENSEMBL:ENSMUSG00000035804 MGI:96572 protein coding gene insulin I
19 gene 52.303521 52.308652 positive MGI_C57BL6J_6303198 Gm50331 ENSEMBL:ENSMUSG00000118128 MGI:6303198 lncRNA gene predicted gene, 50331
19 gene 52.337165 52.345933 positive MGI_C57BL6J_6303200 Gm50332 ENSEMBL:ENSMUSG00000118114 MGI:6303200 lncRNA gene predicted gene, 50332
19 gene 52.372948 52.389660 negative MGI_C57BL6J_5624745 Gm41860 NCBI_Gene:105246590 MGI:5624745 lncRNA gene predicted gene, 41860
19 gene 52.923181 52.941209 positive MGI_C57BL6J_3035466 AA387883 NCBI_Gene:100043450,ENSEMBL:ENSMUSG00000117896 MGI:3035466 lncRNA gene expressed sequence AA387883
19 gene 52.931926 53.040214 negative MGI_C57BL6J_2180003 Xpnpep1 NCBI_Gene:170750,ENSEMBL:ENSMUSG00000025027 MGI:2180003 protein coding gene X-prolyl aminopeptidase (aminopeptidase P) 1, soluble
19 gene 52.943109 52.945972 negative MGI_C57BL6J_5624746 Gm41861 NCBI_Gene:105246591 MGI:5624746 lncRNA gene predicted gene, 41861
19 gene 53.010656 53.010756 negative MGI_C57BL6J_5531214 Mir6407 miRBase:MI0021944,NCBI_Gene:102465220,ENSEMBL:ENSMUSG00000098730 MGI:5531214 miRNA gene microRNA 6407
19 gene 53.033648 53.084516 positive MGI_C57BL6J_1925707 1700054A03Rik NCBI_Gene:78457,ENSEMBL:ENSMUSG00000099988 MGI:1925707 lncRNA gene RIKEN cDNA 1700054A03 gene
19 gene 53.050716 53.105907 negative MGI_C57BL6J_5589393 Gm30234 NCBI_Gene:102632061 MGI:5589393 lncRNA gene predicted gene, 30234
19 gene 53.085037 53.088696 positive MGI_C57BL6J_5624747 Gm41862 NCBI_Gene:105246592 MGI:5624747 lncRNA gene predicted gene, 41862
19 gene 53.127579 53.131793 positive MGI_C57BL6J_5589540 Gm30381 NCBI_Gene:102632253,ENSEMBL:ENSMUSG00000118233 MGI:5589540 lncRNA gene predicted gene, 30381
19 gene 53.133413 53.139839 negative MGI_C57BL6J_3780026 Gm9618 NCBI_Gene:674277,ENSEMBL:ENSMUSG00000118003 MGI:3780026 lncRNA gene predicted gene 9618
19 gene 53.140443 53.247399 positive MGI_C57BL6J_1351615 Add3 NCBI_Gene:27360,ENSEMBL:ENSMUSG00000025026 MGI:1351615 protein coding gene adducin 3 (gamma)
19 gene 53.159757 53.159863 negative MGI_C57BL6J_5454501 Gm24724 ENSEMBL:ENSMUSG00000088855 MGI:5454501 snRNA gene predicted gene, 24724
19 gene 53.248736 53.265405 negative MGI_C57BL6J_1916569 1700001K23Rik NCBI_Gene:69319,ENSEMBL:ENSMUSG00000118314 MGI:1916569 lncRNA gene RIKEN cDNA 1700001K23 gene
19 pseudogene 53.265747 53.266864 positive MGI_C57BL6J_5595498 Gm36339 NCBI_Gene:102640219,ENSEMBL:ENSMUSG00000118350 MGI:5595498 pseudogene predicted gene, 36339
19 gene 53.310414 53.375810 positive MGI_C57BL6J_97245 Mxi1 NCBI_Gene:17859,ENSEMBL:ENSMUSG00000025025 MGI:97245 protein coding gene MAX interactor 1, dimerization protein
19 gene 53.317356 53.326998 negative MGI_C57BL6J_5589700 Gm30541 NCBI_Gene:102632479,ENSEMBL:ENSMUSG00000118369 MGI:5589700 lncRNA gene predicted gene, 30541
19 gene 53.371566 53.371766 negative MGI_C57BL6J_3704501 Gm10197 ENSEMBL:ENSMUSG00000067085 MGI:3704501 protein coding gene predicted gene 10197
19 gene 53.379214 53.390917 negative MGI_C57BL6J_1923729 Smndc1 NCBI_Gene:76479,ENSEMBL:ENSMUSG00000025024 MGI:1923729 protein coding gene survival motor neuron domain containing 1
19 gene 53.390789 53.391795 positive MGI_C57BL6J_1924742 8030456M14Rik ENSEMBL:ENSMUSG00000117768 MGI:1924742 lncRNA gene RIKEN cDNA 8030456M14 gene
19 gene 53.441212 53.464796 negative MGI_C57BL6J_1922001 Mirt1 NCBI_Gene:381232,ENSEMBL:ENSMUSG00000097636 MGI:1922001 lncRNA gene myocardial infarction associated transcript 1
19 gene 53.460066 53.462731 positive MGI_C57BL6J_1921149 4833407H14Rik NCBI_Gene:73899,ENSEMBL:ENSMUSG00000097779 MGI:1921149 lncRNA gene RIKEN cDNA 4833407H14 gene
19 gene 53.483494 53.486485 positive MGI_C57BL6J_6303297 Gm50393 ENSEMBL:ENSMUSG00000118378 MGI:6303297 unclassified gene predicted gene, 50393
19 gene 53.488977 53.492649 negative MGI_C57BL6J_5589985 Gm30826 NCBI_Gene:102632863 MGI:5589985 lncRNA gene predicted gene, 30826
19 gene 53.528609 53.529655 negative MGI_C57BL6J_6303299 Gm50394 ENSEMBL:ENSMUSG00000118210 MGI:6303299 lncRNA gene predicted gene, 50394
19 gene 53.529109 53.542431 positive MGI_C57BL6J_2685183 Dusp5 NCBI_Gene:240672,ENSEMBL:ENSMUSG00000034765 MGI:2685183 protein coding gene dual specificity phosphatase 5
19 pseudogene 53.588151 53.589068 negative MGI_C57BL6J_108008 Nutf2-ps1 NCBI_Gene:100043462,ENSEMBL:ENSMUSG00000071497 MGI:108008 pseudogene nuclear transport factor 2, pseudogene 1
19 gene 53.598542 53.599411 negative MGI_C57BL6J_6303314 Gm50402 ENSEMBL:ENSMUSG00000118159 MGI:6303314 unclassified gene predicted gene, 50402
19 gene 53.600396 53.645833 positive MGI_C57BL6J_1339795 Smc3 NCBI_Gene:13006,ENSEMBL:ENSMUSG00000024974 MGI:1339795 protein coding gene structural maintenance of chromosomes 3
19 gene 53.660989 53.867083 positive MGI_C57BL6J_1920963 Rbm20 NCBI_Gene:73713,ENSEMBL:ENSMUSG00000043639 MGI:1920963 protein coding gene RNA binding motif protein 20
19 gene 53.673178 53.675863 negative MGI_C57BL6J_5826290 Gm46653 NCBI_Gene:108168414 MGI:5826290 lncRNA gene predicted gene, 46653
19 gene 53.754244 53.758239 positive MGI_C57BL6J_5590102 Gm30943 NCBI_Gene:102633013 MGI:5590102 lncRNA gene predicted gene, 30943
19 pseudogene 53.767891 53.768310 negative MGI_C57BL6J_3826538 Gm16298 ENSEMBL:ENSMUSG00000089807 MGI:3826538 pseudogene predicted gene 16298
19 gene 53.770365 53.788290 negative MGI_C57BL6J_5590049 Gm30890 NCBI_Gene:102632944 MGI:5590049 lncRNA gene predicted gene, 30890
19 gene 53.819252 53.825401 negative MGI_C57BL6J_3826539 Gm16299 NCBI_Gene:102641509,ENSEMBL:ENSMUSG00000089679 MGI:3826539 lncRNA gene predicted gene 16299
19 gene 53.855298 53.860220 negative MGI_C57BL6J_5624748 Gm41863 NCBI_Gene:105246593 MGI:5624748 lncRNA gene predicted gene, 41863
19 gene 53.871785 53.903185 negative MGI_C57BL6J_5590149 Gm30990 NCBI_Gene:102633075 MGI:5590149 lncRNA gene predicted gene, 30990
19 pseudogene 53.883367 53.883768 positive MGI_C57BL6J_6303101 Gm50272 ENSEMBL:ENSMUSG00000117693 MGI:6303101 pseudogene predicted gene, 50272
19 gene 53.892231 53.929861 positive MGI_C57BL6J_107490 Pdcd4 NCBI_Gene:18569,ENSEMBL:ENSMUSG00000024975 MGI:107490 protein coding gene programmed cell death 4
19 gene 53.903996 53.904958 positive MGI_C57BL6J_1922933 2310035P21Rik NA NA unclassified gene RIKEN cDNA 2310035P21 gene
19 gene 53.929656 53.944643 negative MGI_C57BL6J_1913610 Bbip1 NCBI_Gene:100503572,ENSEMBL:ENSMUSG00000084957 MGI:1913610 protein coding gene BBSome interacting protein 1
19 gene 53.944232 54.033280 positive MGI_C57BL6J_1927197 Shoc2 NCBI_Gene:56392,ENSEMBL:ENSMUSG00000024976 MGI:1927197 protein coding gene Shoc2, leucine rich repeat scaffold protein
19 gene 53.960355 53.962769 negative MGI_C57BL6J_6303102 Gm50273 ENSEMBL:ENSMUSG00000117704 MGI:6303102 unclassified gene predicted gene, 50273
19 gene 53.976462 54.001442 negative MGI_C57BL6J_1922206 4930484I04Rik ENSEMBL:ENSMUSG00000117981 MGI:1922206 lncRNA gene RIKEN cDNA 4930484I04 gene
19 gene 54.044151 54.048982 positive MGI_C57BL6J_87934 Adra2a NCBI_Gene:11551,ENSEMBL:ENSMUSG00000033717 MGI:87934 protein coding gene adrenergic receptor, alpha 2a
19 gene 54.084559 54.086658 positive MGI_C57BL6J_6302959 Gm50186 ENSEMBL:ENSMUSG00000117921 MGI:6302959 lncRNA gene predicted gene, 50186
19 gene 54.154877 54.175117 positive MGI_C57BL6J_5624750 Gm41865 NCBI_Gene:105246595 MGI:5624750 lncRNA gene predicted gene, 41865
19 gene 54.198385 54.201323 negative MGI_C57BL6J_5624751 Gm41866 NCBI_Gene:105246596 MGI:5624751 lncRNA gene predicted gene, 41866
19 gene 54.198391 54.201454 positive MGI_C57BL6J_6302961 Gm50187 ENSEMBL:ENSMUSG00000118324 MGI:6302961 unclassified gene predicted gene, 50187
19 pseudogene 54.444980 54.445204 positive MGI_C57BL6J_6302963 Gm50188 ENSEMBL:ENSMUSG00000117755 MGI:6302963 pseudogene predicted gene, 50188
19 gene 54.465865 54.586424 positive MGI_C57BL6J_5590460 Gm31301 NCBI_Gene:102633487 MGI:5590460 lncRNA gene predicted gene, 31301
19 gene 54.758648 54.760955 negative MGI_C57BL6J_5624752 Gm41867 NCBI_Gene:105246597 MGI:5624752 lncRNA gene predicted gene, 41867
19 gene 54.923805 54.936724 negative MGI_C57BL6J_6302966 Gm50191 ENSEMBL:ENSMUSG00000118207 MGI:6302966 lncRNA gene predicted gene, 50191
19 gene 55.067268 55.127238 negative MGI_C57BL6J_109162 Gpam NCBI_Gene:14732,ENSEMBL:ENSMUSG00000024978 MGI:109162 protein coding gene glycerol-3-phosphate acyltransferase, mitochondrial
19 gene 55.099502 55.118931 positive MGI_C57BL6J_5590515 Gm31356 NCBI_Gene:102633560,ENSEMBL:ENSMUSG00000118099 MGI:5590515 lncRNA gene predicted gene, 31356
19 gene 55.127314 55.140840 positive MGI_C57BL6J_5590577 Gm31418 NCBI_Gene:102633636 MGI:5590577 lncRNA gene predicted gene, 31418
19 gene 55.132642 55.134832 negative MGI_C57BL6J_3642924 Gm10755 NA NA unclassified gene predicted gene 10755
19 gene 55.180733 55.196313 positive MGI_C57BL6J_109574 Tectb NCBI_Gene:21684,ENSEMBL:ENSMUSG00000024979 MGI:109574 protein coding gene tectorin beta
19 gene 55.192678 55.192734 positive MGI_C57BL6J_5530856 Mir6715 miRBase:MI0025026,NCBI_Gene:102465990,ENSEMBL:ENSMUSG00000098289 MGI:5530856 miRNA gene microRNA 6715
19 gene 55.198098 55.241236 negative MGI_C57BL6J_106025 Gucy2g NCBI_Gene:73707,ENSEMBL:ENSMUSG00000055523 MGI:106025 protein coding gene guanylate cyclase 2g
19 gene 55.251884 55.297720 positive MGI_C57BL6J_1919129 Acsl5 NCBI_Gene:433256,ENSEMBL:ENSMUSG00000024981 MGI:1919129 protein coding gene acyl-CoA synthetase long-chain family member 5
19 gene 55.262382 55.274479 negative MGI_C57BL6J_5590754 Gm31595 NCBI_Gene:102633871 MGI:5590754 lncRNA gene predicted gene, 31595
19 gene 55.271291 55.316032 negative MGI_C57BL6J_1914230 Zdhhc6 NCBI_Gene:66980,ENSEMBL:ENSMUSG00000024982 MGI:1914230 protein coding gene zinc finger, DHHC domain containing 6
19 gene 55.316057 55.627461 positive MGI_C57BL6J_1855699 Vti1a NCBI_Gene:53611,ENSEMBL:ENSMUSG00000024983 MGI:1855699 protein coding gene vesicle transport through interaction with t-SNAREs 1A
19 gene 55.480917 55.484622 negative MGI_C57BL6J_3782650 Gm4466 NA NA unclassified gene predicted gene 4466
19 gene 55.555873 55.556183 negative MGI_C57BL6J_1917659 2310066F23Rik NA NA unclassified gene RIKEN cDNA 2310066F23 gene
19 gene 55.640589 55.702204 negative MGI_C57BL6J_1924844 4930552P12Rik NCBI_Gene:77594,ENSEMBL:ENSMUSG00000097632 MGI:1924844 lncRNA gene RIKEN cDNA 4930552P12 gene
19 gene 55.701143 55.702134 positive MGI_C57BL6J_5624756 Gm41871 NCBI_Gene:105246602 MGI:5624756 lncRNA gene predicted gene, 41871
19 gene 55.734407 55.743225 negative MGI_C57BL6J_5590893 Gm31734 NCBI_Gene:102634055 MGI:5590893 lncRNA gene predicted gene, 31734
19 gene 55.741785 55.933661 positive MGI_C57BL6J_1202879 Tcf7l2 NCBI_Gene:21416,ENSEMBL:ENSMUSG00000024985 MGI:1202879 protein coding gene transcription factor 7 like 2, T cell specific, HMG box
19 gene 55.841672 55.845897 positive MGI_C57BL6J_1349458 Ppnr ENSEMBL:ENSMUSG00000099746 MGI:1349458 lncRNA gene per-pentamer repeat gene
19 gene 55.940237 55.950980 positive MGI_C57BL6J_5624757 Gm41872 NCBI_Gene:105246603 MGI:5624757 lncRNA gene predicted gene, 41872
19 pseudogene 56.012529 56.012925 positive MGI_C57BL6J_6302881 Gm50135 ENSEMBL:ENSMUSG00000117833 MGI:6302881 pseudogene predicted gene, 50135
19 gene 56.035096 56.040941 positive MGI_C57BL6J_3041200 D730002M21Rik ENSEMBL:ENSMUSG00000117827 MGI:3041200 lncRNA gene RIKEN cDNA D730002M21 gene
19 gene 56.066128 56.066934 positive MGI_C57BL6J_1923871 1700106J12Rik NA NA unclassified gene RIKEN cDNA 1700106J12 gene
19 gene 56.077954 56.081392 positive MGI_C57BL6J_3782654 Gm4470 NCBI_Gene:102634217 MGI:3782654 lncRNA gene predicted gene 4470
19 gene 56.105689 56.140607 positive MGI_C57BL6J_5591071 Gm31912 NCBI_Gene:102634291,ENSEMBL:ENSMUSG00000117695 MGI:5591071 lncRNA gene predicted gene, 31912
19 gene 56.155105 56.176419 positive MGI_C57BL6J_5591124 Gm31965 NCBI_Gene:102634365 MGI:5591124 lncRNA gene predicted gene, 31965
19 gene 56.177735 56.199050 positive MGI_C57BL6J_5591187 Gm32028 NCBI_Gene:102634447 MGI:5591187 lncRNA gene predicted gene, 32028
19 gene 56.263413 56.266917 negative MGI_C57BL6J_5591303 Gm32144 NCBI_Gene:102634603 MGI:5591303 lncRNA gene predicted gene, 32144
19 gene 56.273194 56.292830 negative MGI_C57BL6J_5591416 Gm32257 NCBI_Gene:102634750 MGI:5591416 lncRNA gene predicted gene, 32257
19 gene 56.277518 56.277645 negative MGI_C57BL6J_5452048 Gm22271 ENSEMBL:ENSMUSG00000077223 MGI:5452048 snoRNA gene predicted gene, 22271
19 gene 56.287109 56.320822 positive MGI_C57BL6J_1196378 Habp2 NCBI_Gene:226243,ENSEMBL:ENSMUSG00000025075 MGI:1196378 protein coding gene hyaluronic acid binding protein 2
19 gene 56.320035 56.390063 negative MGI_C57BL6J_1098765 Nrap NCBI_Gene:18175,ENSEMBL:ENSMUSG00000049134 MGI:1098765 protein coding gene nebulin-related anchoring protein
19 gene 56.356412 56.366241 positive MGI_C57BL6J_4938024 Gm17197 NCBI_Gene:102634685,ENSEMBL:ENSMUSG00000090990 MGI:4938024 lncRNA gene predicted gene 17197
19 gene 56.396634 56.442348 positive MGI_C57BL6J_109383 Casp7 NCBI_Gene:12369,ENSEMBL:ENSMUSG00000025076 MGI:109383 protein coding gene caspase 7
19 gene 56.442446 56.455000 negative MGI_C57BL6J_5826294 Gm46657 NCBI_Gene:108168418 MGI:5826294 lncRNA gene predicted gene, 46657
19 gene 56.457275 56.486752 positive MGI_C57BL6J_2443041 Plekhs1 NCBI_Gene:226245,ENSEMBL:ENSMUSG00000035818 MGI:2443041 protein coding gene pleckstrin homology domain containing, family S member 1
19 gene 56.529161 56.548284 negative MGI_C57BL6J_1930042 Dclre1a NCBI_Gene:55947,ENSEMBL:ENSMUSG00000025077 MGI:1930042 protein coding gene DNA cross-link repair 1A
19 gene 56.548261 56.603503 positive MGI_C57BL6J_1914116 Nhlrc2 NCBI_Gene:66866,ENSEMBL:ENSMUSG00000025078 MGI:1914116 protein coding gene NHL repeat containing 2
19 gene 56.655970 56.664626 negative MGI_C57BL6J_5591600 Gm32441 NCBI_Gene:102634992,ENSEMBL:ENSMUSG00000117890 MGI:5591600 lncRNA gene predicted gene, 32441
19 gene 56.669067 56.674549 positive MGI_C57BL6J_5591651 Gm32492 NCBI_Gene:102635060,ENSEMBL:ENSMUSG00000117859 MGI:5591651 lncRNA gene predicted gene, 32492
19 gene 56.703751 56.714015 positive MGI_C57BL6J_5591734 Gm32575 NCBI_Gene:102635171 MGI:5591734 lncRNA gene predicted gene, 32575
19 gene 56.722199 56.733113 positive MGI_C57BL6J_87937 Adrb1 NCBI_Gene:11554,ENSEMBL:ENSMUSG00000035283 MGI:87937 protein coding gene adrenergic receptor, beta 1
19 gene 56.741029 56.746913 negative MGI_C57BL6J_6302829 Gm50100 ENSEMBL:ENSMUSG00000117696 MGI:6302829 lncRNA gene predicted gene, 50100
19 gene 56.743045 56.765957 positive MGI_C57BL6J_5591877 Gm32718 NCBI_Gene:102635359 MGI:5591877 lncRNA gene predicted gene, 32718
19 pseudogene 56.754878 56.755428 negative MGI_C57BL6J_3648860 Gm6990 NCBI_Gene:629643,ENSEMBL:ENSMUSG00000067063 MGI:3648860 pseudogene predicted pseudogene 6990
19 gene 56.787481 56.822488 negative MGI_C57BL6J_2445022 Ccdc186 NCBI_Gene:213993,ENSEMBL:ENSMUSG00000035173 MGI:2445022 protein coding gene coiled-coil domain containing 186
19 gene 56.821962 56.822539 positive MGI_C57BL6J_1922878 1700010L13Rik NA NA protein coding gene RIKEN cDNA 1700010L13 gene
19 gene 56.826171 56.870012 positive MGI_C57BL6J_1933218 Tdrd1 NCBI_Gene:83561,ENSEMBL:ENSMUSG00000025081 MGI:1933218 protein coding gene tudor domain containing 1
19 gene 56.874249 56.912078 positive MGI_C57BL6J_2684334 Vwa2 NCBI_Gene:240675,ENSEMBL:ENSMUSG00000025082 MGI:2684334 protein coding gene von Willebrand factor A domain containing 2
19 gene 56.912354 57.008591 negative MGI_C57BL6J_2147658 Afap1l2 NCBI_Gene:226250,ENSEMBL:ENSMUSG00000025083 MGI:2147658 protein coding gene actin filament associated protein 1-like 2
19 gene 56.977200 56.984849 positive MGI_C57BL6J_5621482 Gm38597 NCBI_Gene:102642146 MGI:5621482 lncRNA gene predicted gene, 38597
19 gene 57.032733 57.315204 negative MGI_C57BL6J_1194500 Ablim1 NCBI_Gene:226251,ENSEMBL:ENSMUSG00000025085 MGI:1194500 protein coding gene actin-binding LIM protein 1
19 gene 57.273960 57.277052 positive MGI_C57BL6J_1925370 4930449E18Rik NCBI_Gene:78120,ENSEMBL:ENSMUSG00000117684 MGI:1925370 lncRNA gene RIKEN cDNA 4930449E18 gene
19 gene 57.323193 57.360899 negative MGI_C57BL6J_2444948 B230217O12Rik NCBI_Gene:320879,ENSEMBL:ENSMUSG00000097785 MGI:2444948 lncRNA gene RIKEN cDNA B230217O12 gene
19 gene 57.323602 57.331224 positive MGI_C57BL6J_6303097 Gm50270 ENSEMBL:ENSMUSG00000117670 MGI:6303097 lncRNA gene predicted gene, 50270
19 gene 57.360680 57.389594 positive MGI_C57BL6J_2147545 Fam160b1 NCBI_Gene:226252,ENSEMBL:ENSMUSG00000033478 MGI:2147545 protein coding gene family with sequence similarity 160, member B1
19 gene 57.404096 57.404275 negative MGI_C57BL6J_1924071 2600017C09Rik NA NA unclassified gene RIKEN cDNA 2600017C09 gene
19 gene 57.404678 57.411272 positive MGI_C57BL6J_5624759 Gm41874 NCBI_Gene:105246606 MGI:5624759 lncRNA gene predicted gene, 41874
19 gene 57.418291 57.423494 negative MGI_C57BL6J_6303099 Gm50271 ENSEMBL:ENSMUSG00000117927 MGI:6303099 lncRNA gene predicted gene, 50271
19 gene 57.452892 57.491005 positive MGI_C57BL6J_1919383 Trub1 NCBI_Gene:72133,ENSEMBL:ENSMUSG00000025086 MGI:1919383 protein coding gene TruB pseudouridine (psi) synthase family member 1
19 gene 57.459572 57.461553 negative MGI_C57BL6J_5477368 Gm26874 ENSEMBL:ENSMUSG00000097374 MGI:5477368 lncRNA gene predicted gene, 26874
19 gene 57.497390 57.512788 positive MGI_C57BL6J_1925323 6720468P15Rik NCBI_Gene:78073,ENSEMBL:ENSMUSG00000117655 MGI:1925323 lncRNA gene RIKEN cDNA 6720468P15 gene
19 gene 57.522180 57.533305 positive MGI_C57BL6J_5592091 Gm32932 NCBI_Gene:102635646,ENSEMBL:ENSMUSG00000118178 MGI:5592091 lncRNA gene predicted gene, 32932
19 pseudogene 57.529582 57.529897 negative MGI_C57BL6J_6303113 Gm50279 ENSEMBL:ENSMUSG00000118248 MGI:6303113 pseudogene predicted gene, 50279
19 gene 57.540466 57.544223 negative MGI_C57BL6J_6303122 Gm50285 ENSEMBL:ENSMUSG00000117770 MGI:6303122 lncRNA gene predicted gene, 50285
19 pseudogene 57.584761 57.584956 positive MGI_C57BL6J_6303124 Gm50286 ENSEMBL:ENSMUSG00000117978 MGI:6303124 pseudogene predicted gene, 50286
19 gene 57.610963 58.133343 positive MGI_C57BL6J_2147749 Atrnl1 NCBI_Gene:226255,ENSEMBL:ENSMUSG00000054843 MGI:2147749 protein coding gene attractin like 1
19 gene 58.022571 58.031893 negative MGI_C57BL6J_5592139 Gm32980 NCBI_Gene:102635712 MGI:5592139 lncRNA gene predicted gene, 32980
19 gene 58.051167 58.051236 positive MGI_C57BL6J_5455845 Mir5623 miRBase:MI0019191,NCBI_Gene:100885835,ENSEMBL:ENSMUSG00000093757 MGI:5455845 miRNA gene microRNA 5623
19 gene 58.091814 58.096031 negative MGI_C57BL6J_6303125 Gm50287 ENSEMBL:ENSMUSG00000117871 MGI:6303125 lncRNA gene predicted gene, 50287
19 gene 58.091818 58.094002 positive MGI_C57BL6J_2442561 E430016L07Rik NA NA unclassified gene RIKEN cDNA E430016L07 gene
19 gene 58.204139 58.236047 positive MGI_C57BL6J_3826543 Gm16277 ENSEMBL:ENSMUSG00000087002 MGI:3826543 lncRNA gene predicted gene 16277
19 gene 58.231333 58.232284 negative MGI_C57BL6J_5624760 Gm41875 NCBI_Gene:105246608 MGI:5624760 lncRNA gene predicted gene, 41875
19 gene 58.235581 58.455946 negative MGI_C57BL6J_1100842 Gfra1 NCBI_Gene:14585,ENSEMBL:ENSMUSG00000025089 MGI:1100842 protein coding gene glial cell line derived neurotrophic factor family receptor alpha 1
19 gene 58.280564 58.294578 negative MGI_C57BL6J_5826287 Gm46650 NCBI_Gene:108168411 MGI:5826287 protein coding gene predicted gene, 46650
19 gene 58.296204 58.300348 positive MGI_C57BL6J_3642351 Gm10007 NCBI_Gene:791347 MGI:3642351 lncRNA gene predicted gene 10007
19 gene 58.456149 58.459592 positive MGI_C57BL6J_5624761 Gm41876 NCBI_Gene:105246609 MGI:5624761 lncRNA gene predicted gene, 41876
19 pseudogene 58.489282 58.489603 positive MGI_C57BL6J_6302958 Gm50185 ENSEMBL:ENSMUSG00000118253 MGI:6302958 pseudogene predicted gene, 50185
19 gene 58.500223 58.508119 positive MGI_C57BL6J_5592465 Gm33306 NCBI_Gene:102636162 MGI:5592465 lncRNA gene predicted gene, 33306
19 gene 58.511993 58.553104 positive MGI_C57BL6J_1922895 Ccdc172 NCBI_Gene:75645,ENSEMBL:ENSMUSG00000025090 MGI:1922895 protein coding gene coiled-coil domain containing 172
19 gene 58.606329 58.629753 positive MGI_C57BL6J_1916305 1810007D17Rik NCBI_Gene:69055,ENSEMBL:ENSMUSG00000100001 MGI:1916305 lncRNA gene RIKEN cDNA 1810007D17 gene
19 gene 58.652498 58.681788 positive MGI_C57BL6J_97722 Pnlip NCBI_Gene:69060,ENSEMBL:ENSMUSG00000046008 MGI:97722 protein coding gene pancreatic lipase
19 gene 58.695506 58.696178 positive MGI_C57BL6J_1925578 1810035K13Rik NCBI_Gene:78328,ENSEMBL:ENSMUSG00000118223 MGI:1925578 lncRNA gene RIKEN cDNA 1810035K13 gene
19 gene 58.698917 58.715770 positive MGI_C57BL6J_1921421 1810018F18Rik NCBI_Gene:69166,ENSEMBL:ENSMUSG00000101088 MGI:1921421 lncRNA gene RIKEN cDNA 1810018F18 gene
19 gene 58.728887 58.744169 positive MGI_C57BL6J_97723 Pnliprp1 NCBI_Gene:18946,ENSEMBL:ENSMUSG00000042179 MGI:97723 protein coding gene pancreatic lipase related protein 1
19 gene 58.742043 58.743761 positive MGI_C57BL6J_1917628 1810073G21Rik NA NA unclassified gene RIKEN cDNA 1810073G21 gene
19 gene 58.759719 58.777534 positive MGI_C57BL6J_1336202 Pnliprp2 NCBI_Gene:18947,ENSEMBL:ENSMUSG00000025091 MGI:1336202 protein coding gene pancreatic lipase-related protein 2
19 gene 58.785803 58.794461 negative MGI_C57BL6J_1914757 1700019N19Rik NCBI_Gene:67507,ENSEMBL:ENSMUSG00000026931 MGI:1914757 protein coding gene RIKEN cDNA 1700019N19 gene
19 gene 58.786608 58.786691 negative MGI_C57BL6J_5452338 Gm22561 ENSEMBL:ENSMUSG00000087956 MGI:5452338 unclassified non-coding RNA gene predicted gene, 22561
19 pseudogene 58.790195 58.790575 positive MGI_C57BL6J_4937977 Gm17150 ENSEMBL:ENSMUSG00000091410 MGI:4937977 pseudogene predicted gene 17150
19 gene 58.794515 58.802121 positive MGI_C57BL6J_5624762 Gm41877 NCBI_Gene:105246610 MGI:5624762 lncRNA gene predicted gene, 41877
19 gene 58.795750 58.943672 negative MGI_C57BL6J_1920692 Hspa12a NCBI_Gene:73442,ENSEMBL:ENSMUSG00000025092 MGI:1920692 protein coding gene heat shock protein 12A
19 gene 58.873930 58.875138 negative MGI_C57BL6J_1921900 4930433M22Rik NA NA unclassified gene RIKEN cDNA 4930433M22 gene
19 gene 58.911673 58.911759 negative MGI_C57BL6J_4834260 Mir3086 miRBase:MI0014049,NCBI_Gene:100526480,ENSEMBL:ENSMUSG00000092813 MGI:4834260 miRNA gene microRNA 3086
19 gene 58.935184 58.971421 positive MGI_C57BL6J_2441717 Eno4 NCBI_Gene:226265,ENSEMBL:ENSMUSG00000048029 MGI:2441717 protein coding gene enolase 4
19 gene 58.973356 59.076124 negative MGI_C57BL6J_1918903 Shtn1 NCBI_Gene:71653,ENSEMBL:ENSMUSG00000041362 MGI:1918903 protein coding gene shootin 1
19 pseudogene 59.087487 59.089034 positive MGI_C57BL6J_3643073 Gm9276 NCBI_Gene:668626,ENSEMBL:ENSMUSG00000118377 MGI:3643073 pseudogene predicted gene 9276
19 gene 59.164480 59.170056 negative MGI_C57BL6J_1277163 Vax1 NCBI_Gene:22326,ENSEMBL:ENSMUSG00000006270 MGI:1277163 protein coding gene ventral anterior homeobox 1
19 gene 59.171624 59.184456 positive MGI_C57BL6J_1923050 4930442E04Rik NCBI_Gene:75800 MGI:1923050 lncRNA gene RIKEN cDNA 4930442E04 gene
19 pseudogene 59.180655 59.181432 positive MGI_C57BL6J_6303359 Gm50429 ENSEMBL:ENSMUSG00000117834 MGI:6303359 pseudogene predicted gene, 50429
19 gene 59.219214 59.237374 positive MGI_C57BL6J_2685627 Kcnk18 NCBI_Gene:332396,ENSEMBL:ENSMUSG00000040901 MGI:2685627 protein coding gene potassium channel, subfamily K, member 18
19 gene 59.259512 59.261419 negative MGI_C57BL6J_5579967 Gm29261 ENSEMBL:ENSMUSG00000101630 MGI:5579967 lncRNA gene predicted gene 29261
19 gene 59.260878 59.296012 positive MGI_C57BL6J_106677 Slc18a2 NCBI_Gene:214084,ENSEMBL:ENSMUSG00000025094 MGI:106677 protein coding gene solute carrier family 18 (vesicular monoamine), member 2
19 gene 59.296084 59.345780 negative MGI_C57BL6J_2677270 Pdzd8 NCBI_Gene:107368,ENSEMBL:ENSMUSG00000074746 MGI:2677270 protein coding gene PDZ domain containing 8
19 pseudogene 59.322290 59.322784 positive MGI_C57BL6J_3704503 Rps12-ps3 NCBI_Gene:100034727,ENSEMBL:ENSMUSG00000067038 MGI:3704503 pseudogene ribosomal protein S12, pseudogene 3
19 pseudogene 59.337576 59.337969 positive MGI_C57BL6J_6303374 Gm50440 ENSEMBL:ENSMUSG00000118276 MGI:6303374 pseudogene predicted gene, 50440
19 gene 59.345908 59.346675 positive MGI_C57BL6J_1919460 1700022C07Rik NA NA unclassified gene RIKEN cDNA 1700022C07 gene

R version 3.6.2 (2019-12-12)
Platform: x86_64-apple-darwin15.6.0 (64-bit)
Running under: macOS Catalina 10.15.7

Matrix products: default
BLAS:   /Library/Frameworks/R.framework/Versions/3.6/Resources/lib/libRblas.0.dylib
LAPACK: /Library/Frameworks/R.framework/Versions/3.6/Resources/lib/libRlapack.dylib

locale:
[1] en_AU.UTF-8/en_AU.UTF-8/en_AU.UTF-8/C/en_AU.UTF-8/en_AU.UTF-8

attached base packages:
[1] stats     graphics  grDevices utils     datasets  methods   base     

other attached packages:
 [1] abind_1.4-5       qtl2_0.22         reshape2_1.4.4    ggplot2_3.3.5    
 [5] tibble_3.1.2      psych_2.0.7       readxl_1.3.1      cluster_2.1.0    
 [9] dplyr_0.8.5       optparse_1.6.6    rhdf5_2.28.1      mclust_5.4.6     
[13] tidyr_1.0.2       data.table_1.14.0 knitr_1.33        kableExtra_1.1.0 
[17] workflowr_1.6.2  

loaded via a namespace (and not attached):
 [1] httr_1.4.1        bit64_4.0.5       viridisLite_0.4.0 assertthat_0.2.1 
 [5] highr_0.9         blob_1.2.1        cellranger_1.1.0  yaml_2.2.1       
 [9] pillar_1.6.1      RSQLite_2.2.7     backports_1.2.1   lattice_0.20-38  
[13] glue_1.4.2        digest_0.6.27     promises_1.1.0    rvest_0.3.5      
[17] colorspace_2.0-2  htmltools_0.5.1.1 httpuv_1.5.2      plyr_1.8.6       
[21] pkgconfig_2.0.3   purrr_0.3.4       scales_1.1.1      webshot_0.5.2    
[25] whisker_0.4       getopt_1.20.3     later_1.0.0       git2r_0.26.1     
[29] ellipsis_0.3.2    cachem_1.0.5      withr_2.4.2       mnormt_1.5-7     
[33] magrittr_2.0.1    crayon_1.4.1      memoise_2.0.0     evaluate_0.14    
[37] fs_1.4.1          fansi_0.5.0       nlme_3.1-142      xml2_1.3.1       
[41] tools_3.6.2       hms_0.5.3         lifecycle_1.0.0   stringr_1.4.0    
[45] Rhdf5lib_1.6.3    munsell_0.5.0     compiler_3.6.2    rlang_0.4.11     
[49] grid_3.6.2        rstudioapi_0.13   rmarkdown_2.1     gtable_0.3.0     
[53] DBI_1.1.1         R6_2.5.0          fastmap_1.1.0     bit_4.0.4        
[57] utf8_1.2.1        rprojroot_1.3-2   readr_1.3.1       stringi_1.7.2    
[61] parallel_3.6.2    Rcpp_1.0.7        vctrs_0.3.8       tidyselect_1.0.0 
[65] xfun_0.24