芜湖建设工程质量监督站网站河南省建设厅职称网站

pingmian/2026/1/24 16:23:15/文章来源:
芜湖建设工程质量监督站网站,河南省建设厅职称网站,在线设计闪字图片,python网站开发案例第六节#xff0c;我们使用结核病基因数据#xff0c;做了一个数据预处理的实操案例。例子中结核类型#xff0c;包括结核#xff0c;潜隐进展#xff0c;对照和潜隐#xff0c;四个类别。第七节延续上个数据#xff0c;进行了差异分析。 第八节对差异基因进行富集分析。… 第六节我们使用结核病基因数据做了一个数据预处理的实操案例。例子中结核类型包括结核潜隐进展对照和潜隐四个类别。第七节延续上个数据进行了差异分析。 第八节对差异基因进行富集分析。本节进行WGCNA分析。 WGCNA分析 分段代码附运行效果图请查看上节 运行后效果 rm(list ls()) ######清除环境数据# # #step0数据预处理和检查,已经做过step0 # ###############设置工作路径################### workingDir C:/Users/Desktop/GSE152532############工作路径可以修改可以设置为数据存放路径 setwd(workingDir) getwd()################载入R包######################## library(WGCNA) library(data.table)#############################导入数据########################## # The following setting is important, do not omit. options(stringsAsFactors FALSE) #Read in the female liver data set fpkm fread(Gene_expression.csv,headerT)##############数据文件名根据实际修改如果工作路径不是实际数据路径需要添加正确的数据路径 # Take a quick look at what is in the data set dim(fpkm) names(fpkm)####################导入平台数据########################## library(idmap2) idsget_soft_IDs(GPL10558) head(ids)#####################将探针ID改为基因ID########################## fpkm-merge(fpkm,ids,byID)#merge()函数将dat1的探针id与芯片平台探针id相匹配合并到dat1 library(limma) fpkm-avereps(fpkm[,-c(1,99)],IDfpkm$symbol)#多个探针检测一个基因合并一起取其平均值 fpkm-as.data.frame(fpkm)#将矩阵转换为表格 write.table(fpkm, fileFPKM_genesymbol.csv,row.namesT, col.namesT,quoteFALSE,sep,) ###结束后查看文件进行修改# 加载自己的数据# load( group_data_TB_LTBI.Rdata)load(exprSet_clean_mean_filter_log1.RData) #exprSet_cleanload( dataset_TB_LTBI.Rdata) exprSet_clean dataset_TB_LTBI gene_var - apply(exprSet_clean, 1, var)##### 计算基因的方差 keep_genes - gene_var quantile(gene_var, 0.75)##### 筛选方差较大的基因,选择方差前25%的基因 exprSet_clean - exprSet_clean[keep_genes,]##### 保留筛选后的基因 dim(exprSet_clean) save (exprSet_clean,file方差前25per_TB_LTBI.Rdata)#######################基于方差筛选基因################################# fpkm_var - read.csv(FPKM_genesymbol.csv, header TRUE, row.names 1)##### 读入表达矩阵,矩阵的行是基因列是样本 gene_var - apply(fpkm_var, 1, var)##### 计算基因的方差 keep_genes - gene_var quantile(gene_var, 0.75)##### 筛选方差较大的基因,选择方差前25%的基因 fpkm_var - fpkm_var[keep_genes,]##### 保留筛选后的基因write.table(fpkm_var, fileFPKM_var.csv,row.namesT, col.namesT,quoteFALSE,sep,) ###结束后查看文件进行修改##################重新载入数据######################## # The following setting is important, do not omit. options(stringsAsFactors FALSE) #Read in the female liver data set fpkm fread(FPKM_var_filter.csv,headerT)##############数据文件名根据实际修改如果工作路径不是实际数据路径需要添加正确的数据路径 # Take a quick look at what is in the data set dim(fpkm) names(fpkm)datExpr0 as.data.frame(t(fpkm[,-1])) names(datExpr0) fpkm$ID;##########如果第一行是ID命名就写成fpkm$ID rownames(datExpr0) names(fpkm[,-1])##################check missing value and filter #################### load(方差前25per_TB_LTBI.Rdata) datExpr0 exprSet_clean##check missing value library(WGCNA) gsg goodSamplesGenes(datExpr0, verbose 3) gsg$allOKif (!gsg$allOK) {# Optionally, print the gene and sample names that were removed:if (sum(!gsg$goodGenes)0)printFlush(paste(Removing genes:, paste(names(datExpr0)[!gsg$goodGenes], collapse , )))if (sum(!gsg$goodSamples)0)printFlush(paste(Removing samples:, paste(rownames(datExpr0)[!gsg$goodSamples], collapse , )))# Remove the offending genes and samples from the data:datExpr0 datExpr0[gsg$goodSamples, gsg$goodGenes] }##filter #meanFPKM0.5 ####过滤标准可以修改 #nnrow(datExpr0) #datExpr0[n1,]apply(datExpr0[c(1:nrow(datExpr0)),],2,mean) #datExpr0datExpr0[1:n,datExpr0[n1,] meanFPKM] # for meanFpkm in row n1 and it must be above what you set--select meanFpkmopt$meanFpkm(by rp)filtered_fpkmt(datExpr0) #行 样本 列 基因 filtered_fpkmdata.frame(rownames(filtered_fpkm),filtered_fpkm) names(filtered_fpkm)[1]sample write.table(filtered_fpkm, fileFPKM_filter.csv,row.namesF, col.namesT,quoteFALSE,sep\t)# #加载数据 # load(DEG_TB_LTBI_step13.Rdata) # DEG,res,all_diff,limma_clean_res,dataset_TB_LTBI_DEG, # #加载数据 #library(WGCNA) #读取目录名称方便复制粘贴 dir()# # #step1样品聚类step1 # #################################样品聚类#################### #这里行是样品名列为基因名做转置处理 datExpr t(dataset_TB_LTBI_DEG) #初次聚类 sampleTree hclust(dist(datExpr), method average) # Plot the sample tree: Open a graphic output window of size 20 by 15 inches # The user should change the dimensions if the window is too large or too small. #设置绘图窗口 sizeGrWindow(12,9) pdf(file1_sampleCluestering_初次聚类检查偏离样本.pdf,width 12,height 9) par(cex0.6) par(marc(0,4,2,0)) plot(sampleTree, main Sample clustering to detect outliers, sub, xlab, cex.lab 1.5,cex.axis 1.5, cex.main 2)dev.off()# # #step2切割离群样本 # #pdf(file2_sampleCluestering_初次聚类进行切割删除样本.pdf,width 12,height 9) par(cex0.6) par(marc(0,4,2,0)) plot(sampleTree, main Sample clustering to detect outliers , sub, xlab, cex.lab 1.5,cex.axis 1.5, cex.main 2)### 测试画线可以多次尝试 ##############剪切高度问题,这个根据实际设置后可用 abline(h 87, col red)##剪切高度不确定故无红线 dev.off()### Determine cluster under the line clust cutreeStatic(sampleTree, cutHeight 87, minSize 10) table(clust) #clust #0 1 2 #5 57 40 #由于本人案例一刀切出三段需要保留两段用了’或‘逻辑运算符号 ### 需要保留哪个就传如要保留clust编号 keepSamples (clust1|clust2) #剔除离群样本 datExpr0 datExpr[keepSamples, ] #观察新表达矩阵 dim(datExpr0) #[1] 97 2813# #数据保存 # save(datExpr0,file3.聚类后剔除离群样本datExpr0.Rdata)# #数据保存 #load(datExpr0_cluster_filter.Rdata)# # #step3临床性状数据整理与新表达矩阵保持一致 # ##加载自己的临床性状数据 load(design_TB_LTBI.Rdata) traitDatadesigndim(traitData)# Form a data frame analogous to expression data that will hold the clinical traits. fpkmSamples rownames(datExpr0) traitSamples rownames(traitData) #匹配样本名称性状数据与表达数据保证一致 traitRows match(fpkmSamples, traitSamples) datTraits traitData[traitRows,] rownames(datTraits) collectGarbage()# #数据保存 # save(datTraits,file4.剔除离群样本的临床性状数据datTraits.Rdata)# #数据保存 ## # #step4 增加临床性状数据后再次聚类 # # # Re-cluster samples sampleTree2 hclust(dist(datExpr0), method average) # Convert traits to a color representation: white means low, red means high, grey means missing entry traitColors numbers2colors(datTraits, signed FALSE) # Plot the sample dendrogram and the colors underneath.#sizeGrWindow(20,20)pdf(file5_Sample cluster dendrogram and trait heatmap.pdf,width12,height12) plotDendroAndColors(sampleTree2, traitColors,groupLabels names(datTraits),main Sample dendrogram and trait heatmap)#Error in .plotOrderedColorSubplot(order order, colors colors, rowLabels rowLabels, : # Length of colors vector not compatible with number of objects in order.dev.off()# # #step5 构建WGCNA网络 # ## Allow multi-threading within WGCNA. At present this call is necessary. # Any error here may be ignored but you may want to update WGCNA if you see one. # Caution: skip this line if you run RStudio or other third-party R environments. # See note above. #检查环境能开几个线程 enableWGCNAThreads()# Choose a set of soft-thresholding powers #设置阈值范围WGCNA是无标度网络scale free,节点连结数服从幂次定律分布。连接数越多核心节点越少 powers c(1:15)# Call the network topology analysis function #网络拓扑分析 sft pickSoftThreshold(datExpr0, powerVector powers, verbose 5)# Plot the results: sizeGrWindow(15, 9) pdf(file6_Scale independence选阈值测试过程.pdf,width9,height5) #pdf(fileRplot03.pdf,width9,height5) par(mfrow c(1,2)) cex1 0.9 # Scale-free topology fit index as a function of the soft-thresholding power #无标度拓扑拟合指标作为软阈值能力的函数根据下图结果挑选合适阈值 plot(sft$fitIndices[,1], -sign(sft$fitIndices[,3])*sft$fitIndices[,2],xlabSoft Threshold (power),ylabScale Free Topology Model Fit,signed R^2,typen,main paste(Scale independence)); text(sft$fitIndices[,1], -sign(sft$fitIndices[,3])*sft$fitIndices[,2],labelspowers,cexcex1,colred); # this line corresponds to using an R^2 cut-off of h abline(h0.90,colred) # Mean connectivity as a function of the soft-thresholding power plot(sft$fitIndices[,1], sft$fitIndices[,5],xlabSoft Threshold (power),ylabMean Connectivity, typen,main paste(Mean connectivity)) text(sft$fitIndices[,1], sft$fitIndices[,5], labelspowers, cexcex1,colred) dev.off()######chose the softPower #选择阈值 softPower sft$powerEstimate adjacency adjacency(datExpr0, power softPower)##### Turn adjacency into topological overlap #将邻接转换为拓扑重叠 TOM TOMsimilarity(adjacency); dissTOM 1-TOM# Call the hierarchical clustering function #无标度网络阈值参数确定后调用分层聚类函数 #基于TOM的不相似性基因聚类 geneTree hclust(as.dist(dissTOM), method average); # Plot the resulting clustering tree (dendrogram)#sizeGrWindow(12,9) pdf(file7_Gene clustering on TOM-based dissimilarity基因聚类图.pdf,width12,height9) plot(geneTree, xlab, sub, main Gene clustering on TOM-based dissimilarity,labels FALSE, hang 0.04) dev.off()#聚类模块最小的基因数量 # We like large modules, so we set the minimum module size relatively high: minModuleSize 30# Module identification using dynamic tree cut: #使用dynamic tree cut进行模块识别 dynamicMods cutreeDynamic(dendro geneTree, distM dissTOM,deepSplit 2, pamRespectsDendro FALSE,minClusterSize minModuleSize); table(dynamicMods)# Convert numeric lables into colors #给不同模块分配颜色 dynamicColors labels2colors(dynamicMods) table(dynamicColors) # Plot the dendrogram and colors underneath #sizeGrWindow(8,6) pdf(file8_带颜色标识的聚类树Dynamic Tree Cut.pdf,width8,height6) plotDendroAndColors(geneTree, dynamicColors, Dynamic Tree Cut,dendroLabels FALSE, hang 0.03,addGuide TRUE, guideHang 0.05,main Gene dendrogram and module colors) dev.off()# Calculate eigengenes MEList moduleEigengenes(datExpr0, colors dynamicColors) MEs MEList$eigengenes # Calculate dissimilarity of module eigengenes MEDiss 1-cor(MEs); # Cluster module eigengenes METree hclust(as.dist(MEDiss), method average) # Plot the result #sizeGrWindow(7, 6) pdf(file9_Clustering of module eigengenes.pdf,width7,height6) plot(METree, main Clustering of module eigengenes,xlab , sub ) MEDissThres 0.25######剪切高度可修改 # Plot the cut line into the dendrogram abline(hMEDissThres, col red) dev.off()# Call an automatic merging function #根据前面设置的剪切高度对模块进行合并 merge mergeCloseModules(datExpr0, dynamicColors, cutHeight MEDissThres, verbose 3) # The merged module colors mergedColors merge$colors # Eigengenes of the new merged modules: mergedMEs merge$newMEs#sizeGrWindow(12, 9) pdf(file10_合并模块后的聚类树merged dynamic.pdf, width 9, height 6) plotDendroAndColors(geneTree, cbind(dynamicColors, mergedColors),c(Dynamic Tree Cut, Merged dynamic),dendroLabels FALSE, hang 0.03,addGuide TRUE, guideHang 0.05) dev.off()# Rename to moduleColors moduleColors mergedColors # Construct numerical labels corresponding to the colors #构建相应颜色的数字标签 colorOrder c(grey, standardColors(50)) moduleLabels match(moduleColors, colorOrder)-1 MEs mergedMEs# Save module colors and labels for use in subsequent parts # #数据保存 # save(datExpr0,datTraits,MEs, TOM, dissTOM, moduleLabels, moduleColors, geneTree, sft, file 11_networkConstruction-stepByStep.RData) # #数据保存 #load(11_networkConstruction-stepByStep.RData)# # #step6 计算模块和临床性状相关系数核心挑选色块 # # ##############################relate modules to external clinical triats# Define numbers of genes and samples nGenes ncol(datExpr0) nSamples nrow(datExpr0)#可以修改参数 p值pvalue 更换 moduleTraitCor cor(MEs, datTraits, use p) moduleTraitPvalue corPvalueStudent(moduleTraitCor, nSamples)#sizeGrWindow(10,6) pdf(file12_模块和临床形状关系图Module-trait relationships.pdf,width10,height6) # Will display correlations and their p-values textMatrix paste(signif(moduleTraitCor, 2), \n(,signif(moduleTraitPvalue, 1), ), sep )dim(textMatrix) dim(moduleTraitCor) par(mar c(6, 8.5, 3, 3))# Display the correlation values within a heatmap plot #修改性状类型 data.frame labeledHeatmap(Matrix moduleTraitCor,xLabels names(data.frame(datTraits)),yLabels names(MEs),ySymbols names(MEs),colorLabels FALSE,colors greenWhiteRed(50),textMatrix textMatrix,setStdMargins FALSE,cex.text 0.5,zlim c(-1,1),main paste(Module-trait relationships)) dev.off()#色块 red相关度 0.75# # #step7 定义包含所有datTraits列的可变权重MM and GS # ##定义包含所有datTraits列的可变权重######## Define variable weight containing all column of datTraits###MMgene Module Membership and GSgene Trait Significance# names (colors) of the modules modNames substring(names(MEs), 3)geneModuleMembership as.data.frame(cor(datExpr0, MEs, use p)) MMPvalue as.data.frame(corPvalueStudent(as.matrix(geneModuleMembership), nSamples))names(geneModuleMembership) paste(MM, modNames, sep) names(MMPvalue) paste(p.MM, modNames, sep)#names of those trait traitNamesnames(data.frame(datTraits)) class(datTraits)geneTraitSignificance as.data.frame(cor(datExpr0, datTraits, use p)) GSPvalue as.data.frame(corPvalueStudent(as.matrix(geneTraitSignificance), nSamples))names(geneTraitSignificance) paste(GS., traitNames, sep) names(GSPvalue) paste(p.GS., traitNames, sep)####plot MM vs GS for each trait vs each module##########example:royalblue and CK modulered column match(module, modNames) moduleGenes moduleColorsmoduletraitTB traitColumnmatch(trait,traitNames)sizeGrWindow(7, 7)#par(mfrow c(1,1)) verboseScatterplot(abs(geneModuleMembership[moduleGenes, column]), abs(geneTraitSignificance[moduleGenes, traitColumn]), xlab paste(Module Membership in, module, module), ylab paste(Gene significance for ,trait), main paste(Module membership vs. gene significance\n), cex.main 1.2, cex.lab 1.2, cex.axis 1.2, col module) ######for (trait in traitNames){traitColumnmatch(trait,traitNames)for (module in modNames){column match(module, modNames)moduleGenes moduleColorsmoduleif (nrow(geneModuleMembership[moduleGenes,]) 1){####进行这部分计算必须每个模块内基因数量大于2由于前面设置了最小数量是30这里可以不做这个判断但是grey有可能会出现1个gene,它会导致代码运行的时候中断故设置这一步#sizeGrWindow(7, 7)pdf(filepaste(13_, trait, _, module,_Module membership vs gene significance.pdf,sep),width7,height7)par(mfrow c(1,1))verboseScatterplot(abs(geneModuleMembership[moduleGenes, column]),abs(geneTraitSignificance[moduleGenes, traitColumn]),xlab paste(Module Membership in, module, module),ylab paste(Gene significance for ,trait),main paste(Module membership vs. gene significance\n),cex.main 1.2, cex.lab 1.2, cex.axis 1.2, col module)dev.off()}} }##### names(datExpr0) probes names(data.frame(datExpr0))# # #step8 导出计算完毕的MM and GS # # #################export GS and MM############### geneInfo0 data.frame(probes probes,moduleColor moduleColors)for (Tra in 1:ncol(geneTraitSignificance)) {oldNames names(geneInfo0)geneInfo0 data.frame(geneInfo0, geneTraitSignificance[,Tra],GSPvalue[, Tra])names(geneInfo0) c(oldNames,names(geneTraitSignificance)[Tra],names(GSPvalue)[Tra]) }for (mod in 1:ncol(geneModuleMembership)) {oldNames names(geneInfo0)geneInfo0 data.frame(geneInfo0, geneModuleMembership[,mod],MMPvalue[, mod])names(geneInfo0) c(oldNames,names(geneModuleMembership)[mod],names(MMPvalue)[mod]) } geneOrder order(geneInfo0$moduleColor) geneInfo geneInfo0[geneOrder, ]write.table(geneInfo, file 14_GS_and_MM.xls,sep\t,row.namesF)# # #step9 基因网络热图进行可视化非常耗费内存资源 # #nGenes ncol(datExpr0) nSamples nrow(datExpr0)# Transform dissTOM with a power to make moderately strong connections more visible in the heatmap plotTOM dissTOM^7 # Set diagonal to NA for a nicer plot diag(plotTOM) NA# Call the plot functionsizeGrWindow(9,9) #这个耗电脑内存 pdf(file15_所有基因数量太多Network heatmap plot_all gene.pdf,width9, height9) TOMplot(plotTOM, geneTree, moduleColors, main Network heatmap plot, all genes) dev.off()nSelect 400 # For reproducibility, we set the random seed set.seed(10) select sample(nGenes, size nSelect) selectTOM dissTOM[select, select] # Theres no simple way of restricting a clustering tree to a subset of genes, so we must re-cluster. selectTree hclust(as.dist(selectTOM), method average) selectColors moduleColors[select]# Open a graphical window #sizeGrWindow(9,9) # Taking the dissimilarity to a power, say 10, makes the plot more informative by effectively changing # the color palette; setting the diagonal to NA also improves the clarity of the plot plotDiss selectTOM^7 diag(plotDiss) NApdf(file16_400个基因试试Network heatmap plot_selected genes.pdf,width9, height9) TOMplot(plotDiss, selectTree, selectColors, main Network heatmap plot, selected genes) dev.off()# # #step10 新模块和临床性状热图 合并和拆分两个版本 # ##sizeGrWindow(5,7.5) pdf(file17新模块和临床性状热图_Eigengene dendrogram and Eigengene adjacency heatmap.pdf, width5, height7.5) par(cex 0.9) plotEigengeneNetworks(MEs, , marDendro c(0,4,1,2), marHeatmap c(3,4,1,2), cex.lab 0.8, xLabelsAngle 90) dev.off()#or devide into two parts # Plot the dendrogram #sizeGrWindow(6,6); pdf(file18_Eigengene dendrogram_2.pdf,width6, height6) par(cex 1.0) plotEigengeneNetworks(MEs, Eigengene dendrogram, marDendro c(0,4,2,0), plotHeatmaps FALSE) dev.off()pdf(file19_Eigengene adjacency heatmap_2.pdf,width6, height6) # Plot the heatmap matrix (note: this plot will overwrite the dendrogram plot) par(cex 1.0) plotEigengeneNetworks(MEs, Eigengene adjacency heatmap, marHeatmap c(3,4,2,2), plotDendrograms FALSE, xLabelsAngle 90) dev.off()###########################Exporting to Cytoscape all one by one ########################### # #step11 导出每个模块的边和节点关系Cytoscape 绘图所需 # ## Select each moduleError in exportNetworkToCytoscape(modTOM, edgeFile paste(CytoscapeInput-edges-, : Cannot determine node names: nodeNames is NULL and adjMat has no dimnames.datExpr0 格式需要dataframemodules module #modulered for (mod in 1:nrow(table(moduleColors))) {modules names(table(moduleColors))[mod]# Select module probesprobes names(data.frame(datExpr0)) # inModule (moduleColors modules)modProbes probes[inModule]modGenes modProbes# Select the corresponding Topological OverlapmodTOM TOM[inModule, inModule]dimnames(modTOM) list(modProbes, modProbes)# Export the network into edge and node list files Cytoscape can readcyt exportNetworkToCytoscape(modTOM,edgeFile paste(20_CytoscapeInput-edges-, modules , .txt, sep),nodeFile paste(20_CytoscapeInput-nodes-, modules, .txt, sep),weighted TRUE,threshold 0.02,nodeNames modProbes,altNodeNames modGenes,nodeAttr moduleColors[inModule]) } WGCNA关系网络的构建完毕绘图找核心基因Cytoscape 到底怎么玩

本文来自互联网用户投稿,该文观点仅代表作者本人,不代表本站立场。本站仅提供信息存储空间服务,不拥有所有权,不承担相关法律责任。如若转载,请注明出处:http://www.mzph.cn/pingmian/86138.shtml

如若内容造成侵权/违法违规/事实不符,请联系多彩编程网进行投诉反馈email:809451989@qq.com,一经查实,立即删除!

相关文章

专业做商铺的网站软文关键词排名推广

系统开发环境以及版本 操作系统: Windows_7集成开发工具: Eclipse EE_4.7编译环境:JDK_1.8Web服务器:Tomcat_9.0数据库:MySQL_5.7.23 系统框架 spring框架springmvc框架mybatis框架Logback日志框架安全验证框架maven框…

银行收取网站建设费的会计科目找合伙做网站的

竞赛无人机搭积木式编程(四) ---2023年TI电赛G题空地协同智能消防系统(无人机部分) 无名小哥 2023年9月15日 赛题分析与解题思路综述 飞控用户在学习了TI电赛往届真题开源方案以及用户自定义航点自动飞行功能方案讲解后&#x…

企业网站建设对网络营销有哪些影响站长平台怎么添加网站

文章目录 一、漏洞原因二、漏洞利用1、任意用户注册2、成功进入后台3、越权查看其他用户的仓库源代码4、发现源代码仓库泄漏5、通讯录的地方,发现账号泄漏泄漏三、漏洞进一步利用四、总结五、免责声明一、漏洞原因 可以任意注册账号通过越权,查看其他用户仓库内的源代码造成源…

网站收录提交接口包装设计招聘

从历史上讲,很难对安全的EJB进行测试。 到目前为止,我一直在使用诸如用Arquillian 在WildFly 8.1.x上测试安全的EJB文章中描述的JBossLoginContextFactory等专有技术来测试安全的EJB。 在本年度Devoxx中 , Apache TomEE项目(轻量…

广网站建设钓鱼网站的危害

今年互联网行业陆续裁员减薪,许多人怨声载道的同时也开始另谋出路。而对于程序员更是应该提早做好准备,活跃在兼职接单的最前沿。 我们程序员是一门技术工种,与互联网其他行业相比薪水会相对高一点,不过钱也不是那么好赚的&#…

苏州知名高端网站建设公司昆明网站开发正规培训

文章目录 1.创建字符串2.追加字符串3.替换字符串4.删除字符串5.插入字符串6.字符串反转7.其他操作 在 Java 中字符串不属于基本数据类型,而是对象。Java 提供了 String 类来创建和操作字符串,但String 类是不可变类,一旦一个 String 对象被创…

政务网站建设原则关于制作网站收费标准

在本文中,我们将探讨如何在 .NET Core 应用程序中将日志消息输出到控制台,从而更好地了解应用程序的运行状况。 .NET Core 实现日志打印输出在控制台应用程序中 在 .NET Core 中,日志输出打印是使用 Microsoft.Extensions.Logging 命名空间…

网站数据统计怎么做注册城乡规划师考试教材

网站需求: 1.基于域名[www.openlab.com]可以访问网站内容为 welcome to openlab!!! 2.给该公司创建三个子界面分别显示学生信息,教学资料和缴费网站,基于[www.openlab.com/student] 网站访问学生信息 [www.openlab.com/data]网站访问教学资…

深圳网站建设服务公司网页设计架构

2019独角兽企业重金招聘Python工程师标准>>> 看着简单而又复杂的pom.xml文件,看似熟悉,当自己编写的时候觉得简单,但是看人家项目的时候又觉得复杂的很,现在我们一起来分析这个pom文件。 Maven的坐标为各种构件引入了秩…

网站都是用什么编写的湖南湘潭网站建设

1.数据切分概念 数据的切分[(Sharding)]根据其切分规则的类型,可以分为两种切分模式。一种是按照不同的表(或者Schema)来切分到不同的数据库(主机))之上,这种切可以称之为数据的垂直…

河北秦皇岛建设局网站网站建设可行性分析包括什么

博主前些天发现了一个巨牛的人工智能学习网站,通俗易懂,风趣幽默,忍不住也分享一下给大家 👉点击跳转到教程 Android OkHttp源码阅读详解一 看OkHttp源码,发现OkHttp里面使用了责任链设计模式,所以才要学习…

设计相关的网站招贴广告设计图片

在 Ubuntu 22.04 LTS 中,默认情况下不会自动启动 SSH 服务。如果你想通过 SSH 访问你的 Ubuntu 系统,你需要手动安装 SSH 服务器,并确保 22 端口(SSH 的默认端口)是开放的。以下是必要的步骤: 安装 SSH 服…

嘉兴网站建设品牌升级影响网站速度的因素

“一切皆Socket!” 话虽些许夸张,但是事实也是,现在的网络编程几乎都是用的socket。 ——有感于实际编程和开源项目研究。 我们深谙信息交流的价值,那网络中进程之间如何通信,如我们每天打开浏览器浏览网页时&#xff…

做网络课程的网站罗村网站建设

IP-tools 网管员的第三只眼^ Ip-tools是一款功能齐全的网管软件,可以随时随地的向网管员报告网络的运行情况ip-tools自身集成多种tcp/ip使用工具,如本地信息、链接信息、端口扫描、ping、WHOIS、finger、nslookup、telnet、NetBIOS等功能。界面是全英的&…

遵义市住房城乡建设局网站网站分析seo情况

文章目录1. 题目2. 解题1. 题目 给你字符串 key 和 message ,分别表示一个加密密钥和一段加密消息。 解密 message 的步骤如下: 使用 key 中 26 个英文小写字母第一次出现的顺序作为替换表中的字母 顺序 。将替换表与普通英文字母表对齐,形…

网站建设副业手机网站关于我们

题目描述 本题为填空题,只需要算出结果后,在代码中使用输出语句将所填结果输出即可。 数学家高斯很小的时候就天分过人。一次老师指定的算数题目是:12...100。 高斯立即做出答案:5050! 这次你的任务是类似的。但并非是把一个个…

长沙网站收录佛山网站设计哪家便宜

本文基于ZC706FMCOMMS5的平台,介绍了多片AD9361同步的方法。并将该设计移植到自行设计的ZYNQ70354片AD9361(实现8路同步收发)的电路板上。本设计采用纯逻辑的方式,仅使用了ZYNQ芯片的PL部分。 9361多芯片同步主要包括基带同步和射频同步两大块任务。其中…

网站制作应用知识北京计算机培训机构前十名

关注并标星星CSDN云计算每周三次,打卡即read更快、更全了解泛云圈精彩newsgo go go 大家好!偶是要闻君。近日网传原百度智能硬件事业部总经理、渡鸦科技创始人吕骋已成立AI娱乐公司一家,并已获得来自YCombinator中国等投资;据早前…