好像乱码了。我直接copy上来。
#include "udf.h"
#include "metric.h"
#include "math.h"
#include "mem.h"
#include "sg_mem.h"
/关键参数设定*/
/模型参数/
#define TD 2288 /换热管数量/
#define IDUDF 57 /udf壁面编号/
#define N 887 /单根换热管轴向面网格单元数,个/
#define dy_min 0.008 /换热管轴向网格最小间距,m/
#define f_inc 1.005 /耦合迭代收敛性控制增益因子(备用)/
#define f_dec 0.995 /耦合迭代收敛性控制衰减因子(备用)/
#define nb_factor 0.32 /核态沸腾起始因子,用于初始化核态沸腾换热区起点/
#define fb_factor 0.61 /膜态沸腾起始因子,用于初始化膜态沸腾换热区起点/
#define spv_factor 0.71 /单相汽起始因子,用于初始化单相汽对流换热区起点/
#define p_start 0. /换热段起始坐标,用于壁温分段线性初始化,K/
#define p_end 26. /换热段终点坐标,用于壁温分段线性初始化,K/
#define Tw_in 533.15 /初始化入口处壁面温度,如比入口流体温度高50K,应同时保证低于饱和温度/
#define Tw_nb 640.4 /初始化沸腾起始点壁面温度,如比饱和温度高15K/
#define Tw_fb 665.4 /初始化膜态沸腾起始点壁面温度,如比饱和温度高40K/
#define Tw_spv 685.4 /初始化单相汽对流起始点壁面温度,如比饱和温度高60K/
#define Tw_out 725.4 /初始化出口处壁面温度,如比饱和温度高100K,应同时保证低于钠侧入口温度/
/工况参数/
#define Tl_in 483.15
#define dh_na 0.0396
#define di_water 0.01
#define Psat 17000000
#define Tsat 625.44
#define m_na 1608.24
#define m_water 0.067872
#define G_water 864.605
#define xcrt 0.357431664
/饱和参数/
#define rou_ls 565.18
#define rou_vs 119.48
#define mu_l_s 0.00006472
#define mu_v_s 0.00002418
#define Cp_l_s 10817.
#define Cp_v_s 18309.
#define K_l_s 0.43061
#define K_v_s 0.14174
#define h_l_s 1690035.
#define h_v_s 2547413.
#define hlin 903356.96
#define hv65382 2812819.
#define hv79182 3339351.
#define hfv 857376.9
#define sgm 0.00324
#define n 1.0
DEFINE_EXECUTE_ON_LOADING(on_loading, libname)
{
Set_User_Memory_Name(2,"U-Temperature_Water_Side");
Set_User_Memory_Name(12,"U-HTC_Water_Side");
}
DEFINE_ADJUST(cal_tl_htc, domain)
{
/换热管吸热量求解/
#if !RP_HOST
#endif
#if RP_NODE
QTsub=(h_l_s-hlin)*m_water; QTsup=(h_v_s-hlin)*m_water; QT65382=(hv65382-hlin)*m_water; QT79182=(hv79182-hlin)*m_water; nalht = 0.; barea= 0.; brll=0.; xtd =0.; F =0.; htcfc =0.; pw =0.; htcnb =0.; S =0.; retp=0.; xjdg=xcrt; //膜态沸腾临界含气率 for(i=0;i<TD;i++) //遍历每根换热管 { count = 0; t=Lookup_Thread(domain,IDUDF); if (!t) { Error("Thread IDUDF=%d not found!", IDUDF); return; } //第一次遍历,计算每个管子中face的数量 begin_f_loop(f,t) { ct = F_C0_THREAD(f,t); c = F_C0(f,t); if(C_UDMI(c,ct,15)-i<=0.001) //如果属于第i根传热管 count++; } end_f_loop(f,t) // 跳过空管(防止 malloc(0)) if(count == 0) continue; // 分配存储空间 face_t *selected_faces; if (count>0){ selected_faces = (face_t *)malloc(count * sizeof(face_t)); } int index = 0; // 第二次遍历:存储目标管上所有face的指针 begin_f_loop(f,t) { ct = F_C0_THREAD(f,t); c = F_C0(f,t); if(C_UDMI(c,ct,15)-i<=0.001) //如果属于第i根传热管 selected_faces[index++] = f; } end_f_loop(f,t) // 重新遍历单根传热管 for(j=0;j<N;j++) //遍历轴向面上每个网格 { for (ii = 0; ii < count; ii++) { face_t f = selected_faces[ii]; F_CENTROID(x,f,t); if(x[2] <= Y[j]-1.1*dy_min) //判断网格节点是否匹配 nalht += -WALL_HEAT_FLUX(f, t); //累加每个网格的换热量 } nalht = PRF_GRSUM1(nalht); QTF[j] = nalht; //if(myid==3) // Message("Y=%f, QTF = %f,nalht = %f \n",Y[j],QTF[j],nalht); nalht=0.; } /**耦合求解***/ for (ii = 0; ii < count; ii++) { face_t f = selected_faces[ii]; F_CENTROID(x,f,t); c = F_C0(f,t); F_AREA(A,f,t); ct = F_C0_THREAD(f,t); barea = NV_MAG(A); brll= -WALL_HEAT_FLUX(f,t); brtl=brll/barea; Tall=F_T(f,t); for(j=0;j<N;j++) { if(fabs(x[2]-Y[j]) < 0.2*dy_min) { C_UDMI(c,ct,0) = QTF[j]/*+(-WALL_HEAT_FLUX(f,t)*24*0.85)*/; //C_UDMI(c,ct,0)=传热量 //if(x[0]<1.423440e-3 && x[0]>0 && x[2]<0) // Message("y=%f,Y=%f,QTF =%f,C_UDMI(c,ct,14)=%f,myid=%d \n",x[1],Y[j],QTF[j],C_UDMI(c,ct,14),myid); } } //if(x[0]<1.423440e-3 && x[0]>0 && x[2]<0) // Message("y=%f,Y=%f,QTF =%f,C_UDMI(c,ct,14)=%f\n",x[1],Y[j],QTF[j],C_UDMI(c,ct,14)); if(C_UDMI(c,ct,2)<=Tl_in) C_UDMI(c,ct,2)=Tl_in; if(C_UDMI(c,ct,2)>=791.82) C_UDMI(c,ct,2) = 791.82; //C_UDMI(c,ct,2)=温度,K if(C_UDMI(c,ct,3)<=0) C_UDMI(c,ct,3)=0.000001;if(C_UDMI(c,ct,3)>=1) C_UDMI(c,ct,3)=1; //C_UDMI(c,ct,3)=含气率 if(C_UDMI(c,ct,0)<=0) //传热量 { C_UDMI(c,ct,1)=0; //负传热区 C_UDMI(c,ct,3)=0; C_UDMI(c,ct,4)=0; C_UDMI(c,ct,0)=0; C_UDMI(c,ct,2)= -59.232*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,3)+157.04*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,2)+82.372*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,1)+324.19; if(C_UDMI(c,ct,2)>=Tsat) C_UDMI(c,ct,2) = Tsat; if(C_UDMI(c,ct,2)<Tl_in) C_UDMI(c,ct,2) = Tl_in; /*if(C_UDMI(c,ct,2)>=Tall) C_UDMI(c,ct,2) = f_dec*Tall;*/ C_UDMI(c,ct,5)=-0.0000731372*pow(C_UDMI(c,t,2),3)+0.11175*pow(C_UDMI(c,t,2),2)-58.15118*C_UDMI(c,t,2)+11121.29394; //C_UDMI(c,ct,5)=密度 C_UDMI(c,ct,6)=-0.0000000000145502*pow(C_UDMI(c,t,2),3)+0.0000000245354*pow(C_UDMI(c,t,2),2)-0.0000141776*C_UDMI(c,t,2)+0.00289; //C_UDMI(c,ct,6)=粘度 C_UDMI(c,ct,7)=-0.0000000278887*pow(C_UDMI(c,t,2),3)+0.0000382479*pow(C_UDMI(c,t,2),2)-0.01819*C_UDMI(c,t,2)+3.67367; //C_UDMI(c,ct,7)=热导率 C_UDMI(c,ct,8)=1.58939572558845E-06*pow(C_UDMI(c,t,2),5)-0.00426225564860069*pow(C_UDMI(c,t,2),4)+4.56374090199481*pow(C_UDMI(c,t,2),3)-2438.73022173804*pow(C_UDMI(c,t,2),2)+650360.432339001*C_UDMI(c,t,2)-69238389.168302; //C_UDMI(c,ct,8)=定压比热容 C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); //C_UDMI(c,ct,9)=流速 C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); //C_UDMI(c,ct,10)=雷诺数 C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); //C_UDMI(c,ct,11)=普朗特数 C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.4)*C_UDMI(c,ct,7)/di_water; //C_UDMI(c, ct, 12)=DB公式换热系数 C_UDMI(c,ct,14) = C_UDMI(c,ct,12); //C_UDMI(c,ct,14)=换热系数 } if( C_UDMI(c,ct,0)<=QTsub && C_UDMI(c,ct,0)>0) //单相水 { C_UDMI(c,ct,1)=1;//C_UDMI(c,ct,1)=换热区域编号,1过冷,2泡核,3膜态,4饱和 C_UDMI(c,ct,3)=0; C_UDMI(c,ct,4)=0; //C_UDMI(c,ct,4)=空泡份额 C_UDMI(c,ct,2)=-59.232*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,3)+157.04*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,2)+82.372*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,1)+324.19; if(C_UDMI(c,ct,2)>=Tsat) C_UDMI(c,ct,2) = Tsat; //if(C_UDMI(c,ct,2)>=Tall) // C_UDMI(c,ct,2) = f_dec*Tall; C_UDMI(c,ct,5)=-0.0000731372*pow(C_UDMI(c,t,2),3)+0.11175*pow(C_UDMI(c,t,2),2)-58.15118*C_UDMI(c,t,2)+11121.29394; //C_UDMI(c,ct,5)=密度 C_UDMI(c,ct,6)=-0.0000000000145502*pow(C_UDMI(c,t,2),3)+0.0000000245354*pow(C_UDMI(c,t,2),2)-0.0000141776*C_UDMI(c,t,2)+0.00289; //C_UDMI(c,ct,6)=粘度 C_UDMI(c,ct,7)=-0.0000000278887*pow(C_UDMI(c,t,2),3)+0.0000382479*pow(C_UDMI(c,t,2),2)-0.01819*C_UDMI(c,t,2)+3.67367; //C_UDMI(c,ct,7)=热导率 C_UDMI(c,ct,8)=1.58939572558845E-06*pow(C_UDMI(c,t,2),5)-0.00426225564860069*pow(C_UDMI(c,t,2),4)+4.56374090199481*pow(C_UDMI(c,t,2),3)-2438.73022173804*pow(C_UDMI(c,t,2),2)+650360.432339001*C_UDMI(c,t,2)-69238389.168302; //C_UDMI(c,ct,8)=定压比热容 C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.4)*C_UDMI(c,ct,7)/di_water; C_UDMI(c,ct,14) = C_UDMI(c,ct,12); } if( C_UDMI(c,ct,0)>QTsub && C_UDMI(c,ct,0)<QTsup && C_UDMI(c,ct,3)> xjdg) //膜态沸腾 { C_UDMI(c,ct,1)=3; C_UDMI(c,ct,2) = Tsat; C_UDMI(c,ct,3)=(C_UDMI(c,ct,0)/m_water+hlin-h_l_s)/hfv ;//平衡含汽率 if(C_UDMI(c,ct,3)>1) C_UDMI(c,ct,3)=1; if(C_UDMI(c,ct,3)<0) C_UDMI(c,ct,3)=0.00001; C_UDMI(c,ct,4)=1/(1+(1-C_UDMI(c,ct,3))/C_UDMI(c,ct,3)*rou_vs/rou_ls); C_UDMI(c,ct,5)=rou_vs*C_UDMI(c,ct,4)+rou_ls*(1-C_UDMI(c,ct,4)); //均相流 C_UDMI(c,ct,6)=mu_v_s*C_UDMI(c,ct,4)+mu_l_s*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,7)=K_v_s*C_UDMI(c,ct,4)+K_l_s*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,8)=Cp_v_s*C_UDMI(c,ct,4)+Cp_l_s*(1-C_UDMI(c,ct,4)); //C_UDMI(c,ct,6)=-4.842954771e-6+4.415494732e-8*Tall; //C_UDMI(c,ct,7)=4.962527816-0.01961204*Tall+0.0000261092*pow(Tall,2)-0.0000000115221*pow(Tall,3); //C_UDMI(c,ct,8)=1158168.03485404-4651.253221*Tall+6.23591198*pow(Tall,2)-0.002783744*pow(Tall,3); C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); C_UDMI(c,ct,12)=0.0193*pow(G_water*C_UDMI(c,ct,3)*di_water/mu_v_s,0.8)*pow(mu_v_s*Cp_v_s/K_v_s,1.23)*pow((rou_vs/(rou_vs*C_UDMI(c,ct,4)+rou_ls*(1-C_UDMI(c,ct,4)))),0.68)*pow(rou_vs/rou_ls,0.068)*K_v_s/di_water; C_UDMI(c,ct,14)=0.021*pow(G_water*C_UDMI(c,ct,3)*di_water/mu_v_s,0.8)*pow(C_UDMI(c,ct,11),0.43)*(1-0.1*pow((rou_ls/rou_vs-1)*(1-C_UDMI(c,ct,3)),0.4))*pow(C_UDMI(c,ct,3)+rou_ls/rou_vs*(1-C_UDMI(c,ct,3)),0.8); } if( C_UDMI(c,ct,0)>QTsub && C_UDMI(c,ct,0)<QTsup && C_UDMI(c,ct,3)<=xjdg) //泡核沸腾 { C_UDMI(c,ct,1)=2; C_UDMI(c,ct,2) = Tsat; C_UDMI(c,ct,3)=(C_UDMI(c,ct,0)/m_water+hlin-h_l_s)/hfv ; if(C_UDMI(c,ct,3)>=1) C_UDMI(c,ct,3)=1.0; if(C_UDMI(c,ct,3)<=0) C_UDMI(c,ct,3)=0.00001; C_UDMI(c,ct,4)=1/(1+(1-C_UDMI(c,ct,3))/C_UDMI(c,ct,3)*rou_vs/rou_ls); C_UDMI(c,ct,5)=rou_vs*C_UDMI(c,ct,4)+rou_ls*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,6)=mu_v_s*C_UDMI(c,ct,4)+mu_l_s*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,7)=K_v_s*C_UDMI(c,ct,4)+K_l_s*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,8)=Cp_v_s*C_UDMI(c,ct,4)+Cp_l_s*(1-C_UDMI(c,ct,4)); C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); xtd = pow(C_UDMI(c,ct,3)/(1-C_UDMI(c,ct,3)),0.9)*pow(rou_ls/rou_vs,0.5)*pow(mu_v_s/mu_l_s,0.1); if(xtd>0.1) {F=2.35*pow((xtd+0.213),0.736);} else {F=1.;} htcfc=0.023*K_l_s/di_water*pow((G_water*(1-C_UDMI(c,ct,3))*di_water/mu_l_s),0.8)*pow((mu_l_s*Cp_l_s/K_l_s),0.4)*F; retp=G_water*(1-C_UDMI(c,ct,3))*di_water/mu_l_s*pow(F,1.25)/10000; if(retp<32.5) S=1/(1+0.12*pow(retp,1.14)); if(retp>=32.5&&retp<70) S=1/(1+0.42*pow(retp,0.78)); if(retp>=70) S=0.1; if(Tall<646.) { pw = 299581676.5-1112854.9*Tall + 1056.9284*pow(Tall,2); pw = pw>=Psat? pw:Psat; } else pw = 22115000.; Tgr = Tall-Tsat; if(Tgr<=0) Tgr=0.; htcnb=0.00122*S*pow(Tgr,0.24)*pow((pw-Psat),0.75)*pow(Cp_l_s,0.45)*pow(rou_ls,0.49)*pow(K_l_s,0.79)/(pow(sgm,0.5)*pow(hfv,0.24)*pow(mu_l_s,0.29)*pow(rou_vs,0.24)); C_UDMI(c,ct,12) = pow(pow(htcfc,n)+pow(htcnb,n),1/n); C_UDMI(c,ct,14) = htcfc+htcnb; xtd =0.; F =0.; htcfc =0.; pw =0.; htcnb =0.; S =0.; retp=0.; } if(C_UDMI(c,ct,0) >= QTsup && C_UDMI(c,ct,0) <= QT65382) //单相汽 { C_UDMI(c,ct,1)=4; C_UDMI(c,ct,3)=1; C_UDMI(c,ct,4)=1; //C_UDMI(c,ct,2)=(-47513.190209+pow((pow(47513.190209,2)-4*(-32.65115792)*(-14182632.67-hlin-C_UDMI(c,ct,0)/m_water)),0.5))/(-32.65115792*2); //C_UDMI(c,ct,2)=(-80531.30434781+pow(80531.30434781*80531.30434781-4*(-58.7944664 )*(-24601481.9069136-(hlin+C_UDMI(c,ct,0)/m_water)),0.5))/(-58.7944664 *2); C_UDMI(c,ct,2)=15.75*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,3)+74.564*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,2)-632.88*(C_UDMI(c,ct,0)/m_water+hlin)/1e6+1496.8; if(C_UDMI(c,ct,2)<=Tsat) C_UDMI(c,ct,2) = Tsat; if(C_UDMI(c,ct,2)>=653.82) C_UDMI(c,ct,2) = 653.82; C_UDMI(c,ct,5)=-0.0000768859547860944*pow(C_UDMI(c,t,2),3)+0.164068505626203*pow(C_UDMI(c,t,2),2)-116.820593637976*C_UDMI(c,t,2)+27823.3434320337; C_UDMI(c,ct,6)=-1.15138327125887E-12*pow(C_UDMI(c,t,2),3)+2.47167061066652E-09*pow(C_UDMI(c,t,2),2)-1.72523309775328E-06*C_UDMI(c,t,2)+0.000417905039504174; mu_tw=-4.842954771e-6+4.415494732e-8*Tall; C_UDMI(c,ct,7)=1.64756047401987E-09*pow(C_UDMI(c,t,2),4)-4.66295787905828E-06*pow(C_UDMI(c,t,2),3)+0.00494746512861121*pow(C_UDMI(c,t,2),2)-2.33242356172728*C_UDMI(c,t,2)+412.339466304253; C_UDMI(c,ct,8)=0.000827737277387106*pow(C_UDMI(c,t,2),4)-2.31871761943198*pow(C_UDMI(c,t,2),3)+2433.72280465395*pow(C_UDMI(c,t,2),2)-1134380.21513071*C_UDMI(c,t,2)+198127195.165049; C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.4)*C_UDMI(c,ct,7)/di_water; //C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.33)*C_UDMI(c,ct,7)*pow(C_UDMI(c,ct,6)/mu_tw,0.14)/di_water; C_UDMI(c,ct,14) = C_UDMI(c,ct,12); } if(C_UDMI(c,ct,0)>QT65382 && C_UDMI(c,ct,0)<= QT79182 ) { C_UDMI(c,ct,1)=4; C_UDMI(c,ct,3)=1; C_UDMI(c,ct,4)=1; C_UDMI(c,ct,2)=-85.051*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,3)+959.84*pow((C_UDMI(c,ct,0)/m_water+hlin)/1e6,2)-3225.4*(C_UDMI(c,ct,0)/m_water+hlin)/1e6+4028.5; if(C_UDMI(c,ct,2)<=653.82) C_UDMI(c,ct,2) = 653.82; if(C_UDMI(c,ct,2)>=791.82) C_UDMI(c,ct,2) = 791.82; //if(C_UDMI(c,ct,2)>=Tall) // C_UDMI(c,ct,2) = f_dec*Tall; C_UDMI(c,ct,5)=-0.0000768859547860944*pow(C_UDMI(c,t,2),3)+0.164068505626203*pow(C_UDMI(c,t,2),2)-116.820593637976*C_UDMI(c,t,2)+27823.3434320337; C_UDMI(c,ct,6)=-1.15138327125887E-12*pow(C_UDMI(c,t,2),3)+2.47167061066652E-09*pow(C_UDMI(c,t,2),2)-1.72523309775328E-06*C_UDMI(c,t,2)+0.000417905039504174; mu_tw=-4.842954771e-6+4.415494732e-8*Tall; C_UDMI(c,ct,7)=1.64756047401987E-09*pow(C_UDMI(c,t,2),4)-4.66295787905828E-06*pow(C_UDMI(c,t,2),3)+0.00494746512861121*pow(C_UDMI(c,t,2),2)-2.33242356172728*C_UDMI(c,t,2)+412.339466304253; C_UDMI(c,ct,8)=0.000827737277387106*pow(C_UDMI(c,t,2),4)-2.31871761943198*pow(C_UDMI(c,t,2),3)+2433.72280465395*pow(C_UDMI(c,t,2),2)-1134380.21513071*C_UDMI(c,t,2)+198127195.165049; C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.4)*C_UDMI(c,ct,7)/di_water; //C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.33)*C_UDMI(c,ct,7)*pow(C_UDMI(c,ct,6)/mu_tw,0.14)/di_water; C_UDMI(c,ct,14) = C_UDMI(c,ct,12); } if(C_UDMI(c,ct,0)>QT79182) { C_UDMI(c,ct,1)=4; C_UDMI(c,ct,3)=1; C_UDMI(c,ct,4)=1; C_UDMI(c,ct,2)=791.82; //if(C_UDMI(c,ct,2)>=Tall) // C_UDMI(c,ct,2) = f_dec*Tall; C_UDMI(c,ct,5)=-0.0000768859547860944*pow(C_UDMI(c,t,2),3)+0.164068505626203*pow(C_UDMI(c,t,2),2)-116.820593637976*C_UDMI(c,t,2)+27823.3434320337; C_UDMI(c,ct,6)=-1.15138327125887E-12*pow(C_UDMI(c,t,2),3)+2.47167061066652E-09*pow(C_UDMI(c,t,2),2)-1.72523309775328E-06*C_UDMI(c,t,2)+0.000417905039504174; mu_tw=-4.842954771e-6+4.415494732e-8*Tall; C_UDMI(c,ct,7)=1.64756047401987E-09*pow(C_UDMI(c,t,2),4)-4.66295787905828E-06*pow(C_UDMI(c,t,2),3)+0.00494746512861121*pow(C_UDMI(c,t,2),2)-2.33242356172728*C_UDMI(c,t,2)+412.339466304253; C_UDMI(c,ct,8)=0.000827737277387106*pow(C_UDMI(c,t,2),4)-2.31871761943198*pow(C_UDMI(c,t,2),3)+2433.72280465395*pow(C_UDMI(c,t,2),2)-1134380.21513071*C_UDMI(c,t,2)+198127195.165049; C_UDMI(c,ct,9)=G_water/C_UDMI(c,ct,5); C_UDMI(c,ct,10)=C_UDMI(c,ct,5)*C_UDMI(c,ct,9)*di_water/C_UDMI(c,ct,6); C_UDMI(c,ct,11)=C_UDMI(c,ct,6)*C_UDMI(c,ct,8)/C_UDMI(c,ct,7); C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.4)*C_UDMI(c,ct,7)/di_water; //C_UDMI(c,ct,12)=0.023*pow(C_UDMI(c,ct,10),0.8)*pow(C_UDMI(c,ct,11),0.33)*C_UDMI(c,ct,7)*pow(C_UDMI(c,ct,6)/mu_tw,0.14)/di_water; C_UDMI(c,ct,14) = C_UDMI(c,ct,12); } } free(selected_faces); // 释放内存 selected_faces = NULL; // 防止悬垂指针}
#endif
}
DEFINE_PROFILE(t_water,t,i)
{
face_t f;
cell_t c;
Thread *ct;
}
DEFINE_PROFILE(hct_water,t,i)
{
face_t f;
cell_t c;
Thread *ct;
}