Skip to content

Commit 4834751

Browse files
committed
Moving old stuff out of the way.
1 parent 1d616ec commit 4834751

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

49 files changed

+1041
-1642
lines changed

NDA_Notebook.ipynb

+34-1,636
Large diffs are not rendered by default.
File renamed without changes.
File renamed without changes.

src/NDA_QMC.jl ctk_nda_src/NDA_QMC.jl

+3
Original file line numberDiff line numberDiff line change
@@ -11,6 +11,7 @@ using PyPlot
1111
using Printf
1212
using Sobol
1313

14+
export fprintTeX
1415
export testgauss
1516
export sn_angles
1617
export source_iteration
@@ -26,6 +27,7 @@ export writetab
2627
export readtab
2728
export qmc_vs_sn
2829
export makeqmctab
30+
export makeqmctex
2931
export readdata
3032
export sn_validate
3133
export qmc_sweep
@@ -59,4 +61,5 @@ include("Tim_QMC/qmc_krylov.jl")
5961
include("Tim_QMC/ctk_qmc_sweep.jl")
6062
include("Tim_QMC/ctk_qmc_nda_test.jl")
6163
include("Tim_QMC/sn_test.jl")
64+
include("fprintTex.jl")
6265
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,76 @@
1+
#using LinearAlgebra
2+
#include("qmc_sweep.jl")
3+
"""
4+
qmc_source_iteration(s, qmc_data,tol=1.e-4)
5+
quasi-monte carlo source iteration example script for transport equation.
6+
7+
This is one of the test cases from
8+
9+
Radiative transfer in finite inhomogeneous plane-parallel atmospheres
10+
by Garcia and Siewert
11+
JQSRT (27), 1982 pp 141-148.
12+
13+
Inputs:
14+
-------
15+
N:
16+
Number of internal source particles
17+
Nx:
18+
Number of scalar flux and current tallying cells
19+
na2:
20+
Number of exit angular flux tally bins
21+
s:
22+
Scattering cross section varies with exp(-x/s)
23+
Outputs:
24+
--------
25+
phi_avg:
26+
Array of length Nx, average scalar flux across each cell
27+
phi_edge:
28+
Array of length Nx+1, scalar flux at cell boundaries
29+
J_avg:
30+
Array of length Nx, average cell current
31+
J_edge:
32+
Array of length Nx+1, current at cell boundaries
33+
psi_right:
34+
Array of length nbins, angular flux distribution at right boundary
35+
psi_left:
36+
Array of length nbins, angular flux distribution at left boundary
37+
history:
38+
Infinity norm of change in phi_avg with each iteration
39+
itt:
40+
Number of iterations
41+
"""
42+
43+
44+
function qmc_source_iteration(s, qmc_data, tol=1.e-4)
45+
#
46+
# precomputed data
47+
#
48+
N = qmc_data.N
49+
Nx = qmc_data.Nx
50+
itt = 0
51+
delflux = 1
52+
phi_avg = zeros(Nx)
53+
phi_avg_old = zeros(Nx)
54+
reshist = []
55+
#globalize variables
56+
phi_edge = J_avg = J_edge = exit_right_bins = exit_left_bins = 0
57+
58+
while itt < 200 && delflux > tol
59+
phi_avg, phi_edge, J_avg, J_edge, exit_right_bins, exit_left_bins = qmc_sweep(phi_avg,qmc_data)
60+
delflux = norm(phi_avg - phi_avg_old, Inf)
61+
itt += 1
62+
push!(reshist, delflux)
63+
phi_avg_old .= phi_avg
64+
#println("**********************")
65+
#println("Iteration: ", itt," change = ",delflux)
66+
end
67+
68+
return (phi_avg = phi_avg,
69+
phi_edge = phi_edge,
70+
J_avg = J_avg,
71+
J_edge = J_edge,
72+
psi_right = exit_right_bins,
73+
psi_left = exit_left_bins,
74+
history = reshist,
75+
itt = itt)
76+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,92 @@
1+
#using PyPlot
2+
#include("ckt_qmc_init.jl")
3+
#include("ctk_qmc_source_iteration.jl")
4+
5+
function ctk_qmc_test(N=10^4, Nx=50, na2=11; s=1, plotme=false, tol=1.e-4)
6+
7+
###############################################################################
8+
#### Inputs
9+
###############################################################################
10+
#N = 10^4 #number of QMC particles
11+
#Nx = 50 #number of tally cells
12+
#na2 = 11 #number of angles for angular mesh
13+
#s = 1 #parameter in Garcia/Siewert
14+
15+
#phi_edge = qmc_data.phi_edge
16+
###############################################################################
17+
#### Function Call
18+
###############################################################################
19+
# initialize qmc
20+
qmc_data = qmc_init(N, Nx, na2, s)
21+
# call qmc SI
22+
phi_avg, phi_edge, J_avg, J_edge, psi_right, psi_left, history, itt = qmc_source_iteration(s,qmc_data,tol)
23+
#
24+
if plotme
25+
plotqmd(phi_avg, phi_edge, J_avg, J_edge,
26+
psi_right, psi_left, history, itt, qmc_data)
27+
end
28+
qmctab=sn_tabulate(s, Nx, phi_avg; maketab=false, phiedge=false)
29+
return [qmctab.left qmctab.right]
30+
#
31+
end
32+
33+
function plotqmd(phi_avg, phi_edge, J_avg, J_edge,
34+
psi_right, psi_left, history, itt, qmc_data)
35+
###############################################################################
36+
#### Plotting
37+
###############################################################################
38+
####
39+
iteration = 1:itt
40+
41+
midpoints = qmc_data.midpoints
42+
edges = qmc_data.edges
43+
44+
####
45+
figure(figsize = (6,12))
46+
47+
subplot(311)
48+
plot(midpoints,phi_avg)
49+
ylabel("phi midpoints")
50+
xlabel("midpoints")
51+
title("Cell Averaged Scalar Flux")
52+
53+
# cell Averaged Spatial Derivative of Scalar Flux
54+
subplot(312)
55+
plot(edges,phi_edge)
56+
ylabel("phi edges")
57+
xlabel("cell edges")
58+
title("Cell edge Scalar Flux")
59+
60+
# cell averaged current
61+
subplot(313)
62+
plot(midpoints,J_avg)
63+
ylabel("current")
64+
xlabel("midpoints")
65+
title("Cell Averaged Current")
66+
67+
#left exit bins
68+
figure(figsize = (5,10))
69+
subplot(211)
70+
gsSol = zeros((11,2))
71+
gsSol[:,1] = -1*[0.05,.1,.2,.3,.4,.5,.6,.7,.8,.9,1]
72+
gsSol[:,2] = [0.58966,0.53112,0.44328,0.38031,0.33296,0.29609,0.26656,0.24239,
73+
0.22223,0.20517,0.19055]
74+
plot(gsSol[:,1], gsSol[:,2],"+",label="Garcia et al.")
75+
plot(psi_left[:,1], psi_left[:,2],label="QMC_sweep")
76+
xlabel("-mu")
77+
ylabel("Left Boundary - Angular Flux Dist.")
78+
title("Angular Flux Exit Distributions from Garcia et al., c = 1")
79+
legend()
80+
81+
#right exit bins
82+
subplot(212)
83+
gsSol = zeros((11,2))
84+
gsSol[:,1] = 1*[0.05,.1,.2,.3,.4,.5,.6,.7,.8,.9,1]
85+
gsSol[:,2] = [6.08E-06,6.93E-06,9.64E-06,1.62E-05,4.39E-05,1.69E-04,5.73E-04,
86+
1.51E-03,3.24E-03,5.96E-03,9.77E-03]
87+
plot(gsSol[:,1], gsSol[:,2],"+", label="Garcia et al.")
88+
plot(psi_right[:,1], psi_right[:,2], label="QMC_sweep")
89+
xlabel("mu")
90+
ylabel("Right Boundary - Angular Flux Dist.")
91+
legend()
92+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,16 @@
1+
module NDA_QMC
2+
using LinearAlgebra
3+
using LinearAlgebra.BLAS
4+
using SIAMFANLEquations
5+
using FastGaussQuadrature
6+
7+
export testgauss
8+
export sn_angles
9+
export source_iteration
10+
11+
include("testgauss.jl")
12+
include("sn_angles.jl")
13+
include("source_iteration.jl")
14+
include("transport_sweep.jl")
15+
end
16+
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,18 @@
1+
"""
2+
sn_angles(na=20)
3+
4+
Get double Gauss nodes and weights for SN
5+
"""
6+
function sn_angles(na=20)
7+
na2=floor(Int,na/2)
8+
2*na2 == na || error("odd number of angles")
9+
baseangles, baseweights = gausslegendre(na2)
10+
posweights=baseweights * .5
11+
negweights=copy(posweights)
12+
posangles=(baseangles .+ 1.0) *.5
13+
negangles=-copy(posangles)
14+
weights=[negweights; posweights]
15+
angles=[negangles; posangles]
16+
angles, weights
17+
end
18+
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,59 @@
1+
"""
2+
source_iteration(na2=20, s=Inf)
3+
Source iteration example script for transport equation.
4+
5+
This is one of the test cases from
6+
7+
Radiative transfer in finite inhomogeneous plane-parallel atmospheres
8+
by Garcia and Siewert
9+
JQSRT (27), 1982 pp 141-148.
10+
11+
"""
12+
function source_iteration(na2=20, s=Inf)
13+
nx=2001
14+
(angles, weights) = sn_angles(na2)
15+
tau=5.0; dx=tau/(nx-1);
16+
na=floor(Int,na2/2)
17+
#
18+
# Problem data
19+
#
20+
x=collect(0:dx:tau);
21+
c=exp.(-x/s);
22+
psi_right=zeros(na,);
23+
psi_left=ones(na,);
24+
source=zeros(nx,);
25+
ptmp=zeros(na,)
26+
sweep_data=(c=c, dx=dx, ptmp=ptmp)
27+
psi=zeros(nx,na2)
28+
#
29+
# Source iteration
30+
#
31+
itt=0;
32+
delflux=1;
33+
phi=zeros(nx,)
34+
flux=zeros(nx,)
35+
ithist=[]
36+
while itt < 200 && delflux > 1.e-8
37+
psi = transport_sweep!(psi, phi, psi_left, psi_right,
38+
angles, source, sweep_data);
39+
flux.=psi*weights;
40+
delflux=norm(flux-phi,Inf); itt=itt+1;
41+
push!(ithist,delflux)
42+
phi.=flux;
43+
end
44+
#
45+
# Tabulate the exit distributions to check results.
46+
#
47+
#angleout=[collect(-1.0:.1:-.1); -.05; .05; collect(.1:.1:1.0)]
48+
angleout=[-.05; collect(-.1:-.1:-1.0); .05; collect(.1:.1:1.0)]
49+
na2=length(angleout)
50+
na=floor(Int,na2/2)
51+
psi_left=ones(na,);
52+
psi_right=zeros(na,);
53+
psi = zeros(nx,na2)
54+
ptmp=zeros(na,)
55+
sweep_data=(c=c, dx=dx, ptmp=ptmp)
56+
psi = transport_sweep!(psi, phi, psi_left, psi_right,
57+
angleout, source, sweep_data);
58+
return (left=psi[1,1:na], right=psi[nx,na+1:na2], history=ithist)
59+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,14 @@
1+
function testgauss(m)
2+
x, w = gausslegendre(m)
3+
# Map to [0,1]
4+
w .*= .5; x .+= 1.0; x .*= .5;
5+
errs=zeros(2*m,)
6+
for p=0:2*m-1
7+
exact=1.0/(1.0+p)
8+
y=x.^p
9+
# approx=y'*w
10+
approx=dot(w,y)
11+
errs[p+1]=abs(exact-approx)
12+
end
13+
maximum(errs)
14+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,59 @@
1+
"""
2+
transport_sweep!(psi, phi, psi_left, psi_right, angles, source,
3+
sweep_data)
4+
5+
Take a single transport sweep.
6+
"""
7+
function transport_sweep!(psi, phi, psi_left, psi_right, angles, source,
8+
sweep_data)
9+
10+
c=sweep_data.c;
11+
q=source;
12+
dx=sweep_data.dx;
13+
ptmp=sweep_data.ptmp;
14+
na2=length(angles);
15+
na=floor(Int,na2/2);
16+
nx=length(phi);
17+
#
18+
# Initialize the intensities.
19+
#
20+
psi *= 0.0
21+
@views psi[nx,1:na]=psi_right;
22+
@views psi[1,na+1:na2]=psi_left;
23+
#
24+
#
25+
#
26+
source_total = .5*c.*phi + q;
27+
@views source_average=(source_total[2:nx]+source_total[1:nx-1])*.5;
28+
@views forward_angles=angles[na+1:na2];
29+
@views backward_angles=angles[1:na];
30+
#
31+
vfl=(forward_angles/dx) .+ .5;
32+
vfl=1.0 ./ vfl;
33+
vfr=(forward_angles/dx) .- .5;
34+
dfr=Diagonal(vfr);
35+
#
36+
# Forward sweep
37+
#
38+
ptmp.=psi[1,na+1:na2]
39+
@views for ix=2:nx
40+
psi[ix,na+1:na2] .= ptmp.*vfr
41+
# psi[ix,na+1:na2] .= psi[ix-1,na+1:na2]
42+
# psi[ix,na+1:na2] .*= vfr
43+
psi[ix,na+1:na2] .+= source_average[ix-1]
44+
psi[ix,na+1:na2] .*= vfl
45+
ptmp.=psi[ix,na+1:na2]
46+
end
47+
#
48+
#
49+
# Backward sweep
50+
#
51+
ptmp.=psi[nx,1:na]
52+
@views for ix=nx-1:-1:1
53+
psi[ix,1:na] .= ptmp.*vfr
54+
psi[ix,1:na] .+= source_average[ix]
55+
psi[ix,1:na] .*= vfl
56+
ptmp.=psi[ix,1:na]
57+
end
58+
return psi
59+
end

0 commit comments

Comments
 (0)