Spaces:
Running
on
T4
Running
on
T4
Jacob Gershon
commited on
Commit
·
8a6c540
1
Parent(s):
5337c38
new features
Browse files- app.py +266 -64
- tmp/150l.pdb +0 -0
- tmp/PSSM_lysozyme.csv +164 -0
app.py
CHANGED
@@ -52,7 +52,8 @@ args['helix_bias'] = 0.0
|
|
52 |
def protein_diffusion_model(sequence, seq_len, helix_bias, strand_bias, loop_bias,
|
53 |
secondary_structure, aa_bias, aa_bias_potential,
|
54 |
#target_charge, target_ph, charge_potential,
|
55 |
-
num_steps, noise, hydrophobic_target_score, hydrophobic_potential
|
|
|
56 |
|
57 |
dssp_checkpoint = './SEQDIFF_230205_dssp_hotspots_25mask_EQtasks_mod30.pt'
|
58 |
og_checkpoint = './SEQDIFF_221219_equalTASKS_nostrSELFCOND_mod30.pt'
|
@@ -91,10 +92,21 @@ def protein_diffusion_model(sequence, seq_len, helix_bias, strand_bias, loop_bia
|
|
91 |
aa_seq.append(aa)
|
92 |
|
93 |
S.args['sequence'] = aa_seq
|
|
|
|
|
94 |
else:
|
95 |
S.args['contigs'] = [f'{seq_len}']
|
96 |
L = int(seq_len)
|
97 |
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
98 |
if secondary_structure in ['',None]:
|
99 |
secondary_structure = None
|
100 |
else:
|
@@ -137,6 +149,11 @@ def protein_diffusion_model(sequence, seq_len, helix_bias, strand_bias, loop_bia
|
|
137 |
hydrophobic_potential = 3
|
138 |
potential_bias_list.append(str(hydrophobic_potential))
|
139 |
|
|
|
|
|
|
|
|
|
|
|
140 |
|
141 |
if len(potential_list) > 0:
|
142 |
S.args['potentials'] = ','.join(potential_list)
|
@@ -232,7 +249,6 @@ def display_pdb(path_to_pdb):
|
|
232 |
allowpaymentrequest="" frameborder="0" srcdoc='{x}'></iframe>"""
|
233 |
|
234 |
'''
|
235 |
-
|
236 |
return f"""<iframe style="width: 100%; height:700px" name="result" allow="midi; geolocation; microphone; camera;
|
237 |
display-capture; encrypted-media;" sandbox="allow-modals allow-forms
|
238 |
allow-scripts allow-same-origin allow-popups
|
@@ -240,6 +256,138 @@ def display_pdb(path_to_pdb):
|
|
240 |
allowpaymentrequest="" frameborder="0" srcdoc='{x}'></iframe>"""
|
241 |
'''
|
242 |
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
243 |
def toggle_seq_input(choice):
|
244 |
if choice == "protein length":
|
245 |
return gr.update(visible=True, value=None), gr.update(visible=False, value=None)
|
@@ -252,6 +400,7 @@ def toggle_secondary_structure(choice):
|
|
252 |
elif choice == "explicit":
|
253 |
return gr.update(visible=False, value=None),gr.update(visible=False, value=None),gr.update(visible=False, value=None),gr.update(visible=True, value=None)
|
254 |
|
|
|
255 |
# Define the Gradio interface
|
256 |
with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
257 |
|
@@ -262,7 +411,6 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
262 |
gr.Markdown(f"""
|
263 |
## How does it work?\n
|
264 |
--- [PREPRINT](https://biorxiv.org/content/10.1101/2023.05.08.539766v1) ---
|
265 |
-
|
266 |
Protein sequence and structure co-generation is a long outstanding problem in the field of protein design. By implementing [ddpm](https://arxiv.org/abs/2006.11239) style diffusion over protein seqeuence space we generate protein sequence and structure pairs. Starting with [RoseTTAFold](https://www.science.org/doi/10.1126/science.abj8754), a protein structure prediction network, we finetuned it to predict sequence and structure given a partially noised sequence. By applying losses to both the predicted sequence and structure the model is forced to generate meaningful pairs. Diffusing in sequence space makes it easy to implement potentials to guide the diffusive process toward particular amino acid composition, net charge, and more! Furthermore, you can sample proteins from a family of sequences or even train a small sequence to function classifier to guide generation toward desired sequences.
|
267 |
![fig1](http://files.ipd.uw.edu/pub/sequence_diffusion/figs/diffusion_landscape.png)
|
268 |
|
@@ -280,62 +428,89 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
280 |
|
281 |
with gr.Row().style(equal_height=False):
|
282 |
with gr.Column():
|
283 |
-
gr.
|
284 |
-
|
285 |
-
|
286 |
-
|
287 |
-
|
288 |
-
|
289 |
-
|
290 |
-
|
291 |
-
|
292 |
-
|
293 |
-
|
294 |
-
|
295 |
-
|
296 |
-
|
297 |
-
|
298 |
-
|
299 |
-
|
300 |
-
|
301 |
-
|
302 |
-
|
303 |
-
|
304 |
-
|
305 |
-
|
306 |
-
|
307 |
-
|
308 |
-
|
309 |
-
|
310 |
-
|
311 |
-
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
312 |
|
313 |
-
|
314 |
-
|
315 |
-
|
316 |
-
|
317 |
-
|
318 |
-
|
319 |
-
|
320 |
-
|
321 |
-
|
322 |
-
|
323 |
-
|
324 |
-
|
325 |
-
|
326 |
-
|
327 |
-
|
328 |
-
|
329 |
-
|
330 |
-
|
331 |
-
|
332 |
-
|
333 |
-
|
334 |
-
|
335 |
-
|
336 |
-
|
337 |
-
num_steps = gr.Textbox(label="T", lines=1, placeholder='number of diffusion steps (25 or less will speed things up)')
|
338 |
-
noise = gr.Dropdown(['normal','gmm2 [-1,1]','gmm3 [-1,0,1]'], label='noise type', value='normal')
|
339 |
|
340 |
btn = gr.Button("GENERATE")
|
341 |
|
@@ -353,10 +528,20 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
353 |
|
354 |
gr.Markdown("""### Don't know where to get started? Click on an example below to try it out!""")
|
355 |
gr.Examples(
|
356 |
-
[["","125",0.0,0.0,0.2,"","","","20","normal",'',''],
|
357 |
-
["","100",0.0,0.0,0.0,"","W0.2","2","20","normal",'',''],
|
358 |
-
["","100",0.0,0.0,0.0,
|
359 |
-
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
360 |
inputs=[sequence,
|
361 |
seq_len,
|
362 |
helix_bias,
|
@@ -371,13 +556,23 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
371 |
num_steps,
|
372 |
noise,
|
373 |
hydrophobic_target_score,
|
374 |
-
hydrophobic_potential
|
|
|
|
|
|
|
|
|
|
|
375 |
outputs=[output_seq,
|
376 |
output_pdb,
|
377 |
output_viewer,
|
378 |
plddt_plot],
|
379 |
fn=protein_diffusion_model,
|
380 |
)
|
|
|
|
|
|
|
|
|
|
|
381 |
btn.click(protein_diffusion_model,
|
382 |
[sequence,
|
383 |
seq_len,
|
@@ -393,7 +588,12 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
393 |
num_steps,
|
394 |
noise,
|
395 |
hydrophobic_target_score,
|
396 |
-
hydrophobic_potential
|
|
|
|
|
|
|
|
|
|
|
397 |
[output_seq,
|
398 |
output_pdb,
|
399 |
output_viewer,
|
@@ -402,3 +602,5 @@ with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
|
402 |
demo.queue()
|
403 |
demo.launch(debug=True)
|
404 |
|
|
|
|
|
|
52 |
def protein_diffusion_model(sequence, seq_len, helix_bias, strand_bias, loop_bias,
|
53 |
secondary_structure, aa_bias, aa_bias_potential,
|
54 |
#target_charge, target_ph, charge_potential,
|
55 |
+
num_steps, noise, hydrophobic_target_score, hydrophobic_potential,
|
56 |
+
contigs, pssm, seq_mask, str_mask, rewrite_pdb):
|
57 |
|
58 |
dssp_checkpoint = './SEQDIFF_230205_dssp_hotspots_25mask_EQtasks_mod30.pt'
|
59 |
og_checkpoint = './SEQDIFF_221219_equalTASKS_nostrSELFCOND_mod30.pt'
|
|
|
92 |
aa_seq.append(aa)
|
93 |
|
94 |
S.args['sequence'] = aa_seq
|
95 |
+
elif contigs not in ['',None]:
|
96 |
+
S.args['contigs'] = [contigs]
|
97 |
else:
|
98 |
S.args['contigs'] = [f'{seq_len}']
|
99 |
L = int(seq_len)
|
100 |
|
101 |
+
print('DEBUG: ',rewrite_pdb)
|
102 |
+
if rewrite_pdb not in ['',None]:
|
103 |
+
S.args['pdb'] = rewrite_pdb.name
|
104 |
+
|
105 |
+
if seq_mask not in ['',None]:
|
106 |
+
S.args['inpaint_seq'] = [seq_mask]
|
107 |
+
if str_mask not in ['',None]:
|
108 |
+
S.args['inpaint_str'] = [str_mask]
|
109 |
+
|
110 |
if secondary_structure in ['',None]:
|
111 |
secondary_structure = None
|
112 |
else:
|
|
|
149 |
hydrophobic_potential = 3
|
150 |
potential_bias_list.append(str(hydrophobic_potential))
|
151 |
|
152 |
+
if pssm not in ['',None]:
|
153 |
+
potential_list.append('PSSM')
|
154 |
+
potential_bias_list.append('5')
|
155 |
+
S.args['PSSM'] = pssm.name
|
156 |
+
|
157 |
|
158 |
if len(potential_list) > 0:
|
159 |
S.args['potentials'] = ','.join(potential_list)
|
|
|
249 |
allowpaymentrequest="" frameborder="0" srcdoc='{x}'></iframe>"""
|
250 |
|
251 |
'''
|
|
|
252 |
return f"""<iframe style="width: 100%; height:700px" name="result" allow="midi; geolocation; microphone; camera;
|
253 |
display-capture; encrypted-media;" sandbox="allow-modals allow-forms
|
254 |
allow-scripts allow-same-origin allow-popups
|
|
|
256 |
allowpaymentrequest="" frameborder="0" srcdoc='{x}'></iframe>"""
|
257 |
'''
|
258 |
|
259 |
+
|
260 |
+
|
261 |
+
# MOTIF SCAFFOLDING
|
262 |
+
def get_motif_preview(pdb_id, contigs):
|
263 |
+
'''
|
264 |
+
#function to display selected motif in py3dmol
|
265 |
+
'''
|
266 |
+
input_pdb = fetch_pdb(pdb_id=pdb_id.lower())
|
267 |
+
|
268 |
+
# rewrite pdb
|
269 |
+
parse = parse_pdb(input_pdb)
|
270 |
+
#output_name = './rewrite_'+input_pdb.split('/')[-1]
|
271 |
+
#writepdb(output_name, torch.tensor(parse_og['xyz']),torch.tensor(parse_og['seq']))
|
272 |
+
#parse = parse_pdb(output_name)
|
273 |
+
output_name = input_pdb
|
274 |
+
|
275 |
+
pdb = open(output_name, "r").read()
|
276 |
+
view = py3Dmol.view(width=500, height=500)
|
277 |
+
view.addModel(pdb, "pdb")
|
278 |
+
|
279 |
+
if contigs in ['',0]:
|
280 |
+
contigs = ['0']
|
281 |
+
else:
|
282 |
+
contigs = [contigs]
|
283 |
+
|
284 |
+
print('DEBUG: ',contigs)
|
285 |
+
|
286 |
+
pdb_map = get_mappings(ContigMap(parse,contigs))
|
287 |
+
print('DEBUG: ',pdb_map)
|
288 |
+
print('DEBUG: ',pdb_map['con_ref_idx0'])
|
289 |
+
roi = [x[1]-1 for x in pdb_map['con_ref_pdb_idx']]
|
290 |
+
|
291 |
+
colormap = {0:'#D3D3D3', 1:'#F74CFF'}
|
292 |
+
colors = {i+1: colormap[1] if i in roi else colormap[0] for i in range(parse['xyz'].shape[0])}
|
293 |
+
view.setStyle({"cartoon": {"colorscheme": {"prop": "resi", "map": colors}}})
|
294 |
+
view.zoomTo()
|
295 |
+
output = view._make_html().replace("'", '"')
|
296 |
+
print(view._make_html())
|
297 |
+
x = f"""<!DOCTYPE html><html></center> {output} </center></html>""" # do not use ' in this input
|
298 |
+
|
299 |
+
return f"""<iframe height="500px" width="100%" name="result" allow="midi; geolocation; microphone; camera;
|
300 |
+
display-capture; encrypted-media;" sandbox="allow-modals allow-forms
|
301 |
+
allow-scripts allow-same-origin allow-popups
|
302 |
+
allow-top-navigation-by-user-activation allow-downloads" allowfullscreen=""
|
303 |
+
allowpaymentrequest="" frameborder="0" srcdoc='{x}'></iframe>""", output_name
|
304 |
+
|
305 |
+
def fetch_pdb(pdb_id=None):
|
306 |
+
if pdb_id is None or pdb_id == "":
|
307 |
+
return None
|
308 |
+
else:
|
309 |
+
os.system(f"wget -qnc https://files.rcsb.org/view/{pdb_id}.pdb")
|
310 |
+
return f"{pdb_id}.pdb"
|
311 |
+
|
312 |
+
# MSA AND PSSM GUIDANCE
|
313 |
+
def save_pssm(file_upload):
|
314 |
+
filename = file_upload.name
|
315 |
+
orig_name = file_upload.orig_name
|
316 |
+
if filename.split('.')[-1] in ['fasta', 'a3m']:
|
317 |
+
return msa_to_pssm(file_upload)
|
318 |
+
return filename
|
319 |
+
|
320 |
+
def msa_to_pssm(msa_file):
|
321 |
+
# Define the lookup table for converting amino acids to indices
|
322 |
+
aa_to_index = {'A': 0, 'R': 1, 'N': 2, 'D': 3, 'C': 4, 'Q': 5, 'E': 6, 'G': 7, 'H': 8, 'I': 9, 'L': 10,
|
323 |
+
'K': 11, 'M': 12, 'F': 13, 'P': 14, 'S': 15, 'T': 16, 'W': 17, 'Y': 18, 'V': 19, 'X': 20, '-': 21}
|
324 |
+
# Open the FASTA file and read the sequences
|
325 |
+
records = list(SeqIO.parse(msa_file.name, "fasta"))
|
326 |
+
|
327 |
+
assert len(records) >= 1, "MSA must contain more than one protein sequecne."
|
328 |
+
|
329 |
+
first_seq = str(records[0].seq)
|
330 |
+
aligned_seqs = [first_seq]
|
331 |
+
# print(aligned_seqs)
|
332 |
+
# Perform sequence alignment using the Needleman-Wunsch algorithm
|
333 |
+
aligner = Align.PairwiseAligner()
|
334 |
+
aligner.open_gap_score = -0.7
|
335 |
+
aligner.extend_gap_score = -0.3
|
336 |
+
for record in records[1:]:
|
337 |
+
alignment = aligner.align(first_seq, str(record.seq))[0]
|
338 |
+
alignment = alignment.format().split("\n")
|
339 |
+
al1 = alignment[0]
|
340 |
+
al2 = alignment[2]
|
341 |
+
al1_fin = ""
|
342 |
+
al2_fin = ""
|
343 |
+
percent_gap = al2.count('-')/ len(al2)
|
344 |
+
if percent_gap > 0.4:
|
345 |
+
continue
|
346 |
+
for i in range(len(al1)):
|
347 |
+
if al1[i] != '-':
|
348 |
+
al1_fin += al1[i]
|
349 |
+
al2_fin += al2[i]
|
350 |
+
aligned_seqs.append(str(al2_fin))
|
351 |
+
# Get the length of the aligned sequences
|
352 |
+
aligned_seq_length = len(first_seq)
|
353 |
+
# Initialize the position scoring matrix
|
354 |
+
matrix = np.zeros((22, aligned_seq_length))
|
355 |
+
# Iterate through the aligned sequences and count the amino acids at each position
|
356 |
+
for seq in aligned_seqs:
|
357 |
+
#print(seq)
|
358 |
+
for i in range(aligned_seq_length):
|
359 |
+
if i == len(seq):
|
360 |
+
break
|
361 |
+
amino_acid = seq[i]
|
362 |
+
if amino_acid.upper() not in aa_to_index.keys():
|
363 |
+
continue
|
364 |
+
else:
|
365 |
+
aa_index = aa_to_index[amino_acid.upper()]
|
366 |
+
matrix[aa_index, i] += 1
|
367 |
+
# Normalize the counts to get the frequency of each amino acid at each position
|
368 |
+
matrix /= len(aligned_seqs)
|
369 |
+
print(len(aligned_seqs))
|
370 |
+
matrix[20:,]=0
|
371 |
+
|
372 |
+
outdir = ".".join(msa_file.name.split('.')[:-1]) + ".csv"
|
373 |
+
np.savetxt(outdir, matrix[:21,:].T, delimiter=",")
|
374 |
+
return outdir
|
375 |
+
|
376 |
+
def get_pssm(fasta_msa, input_pssm):
|
377 |
+
|
378 |
+
if input_pssm not in ['',None]:
|
379 |
+
outdir = input_pssm.name
|
380 |
+
else:
|
381 |
+
outdir = save_pssm(fasta_msa)
|
382 |
+
|
383 |
+
pssm = np.loadtxt(outdir, delimiter=",", dtype=float)
|
384 |
+
fig, ax = plt.subplots(figsize=(15,6))
|
385 |
+
plt.imshow(torch.permute(torch.tensor(pssm),(1,0)))
|
386 |
+
|
387 |
+
return fig, outdir
|
388 |
+
|
389 |
+
|
390 |
+
#toggle options
|
391 |
def toggle_seq_input(choice):
|
392 |
if choice == "protein length":
|
393 |
return gr.update(visible=True, value=None), gr.update(visible=False, value=None)
|
|
|
400 |
elif choice == "explicit":
|
401 |
return gr.update(visible=False, value=None),gr.update(visible=False, value=None),gr.update(visible=False, value=None),gr.update(visible=True, value=None)
|
402 |
|
403 |
+
|
404 |
# Define the Gradio interface
|
405 |
with gr.Blocks(theme='ParityError/Interstellar') as demo:
|
406 |
|
|
|
411 |
gr.Markdown(f"""
|
412 |
## How does it work?\n
|
413 |
--- [PREPRINT](https://biorxiv.org/content/10.1101/2023.05.08.539766v1) ---
|
|
|
414 |
Protein sequence and structure co-generation is a long outstanding problem in the field of protein design. By implementing [ddpm](https://arxiv.org/abs/2006.11239) style diffusion over protein seqeuence space we generate protein sequence and structure pairs. Starting with [RoseTTAFold](https://www.science.org/doi/10.1126/science.abj8754), a protein structure prediction network, we finetuned it to predict sequence and structure given a partially noised sequence. By applying losses to both the predicted sequence and structure the model is forced to generate meaningful pairs. Diffusing in sequence space makes it easy to implement potentials to guide the diffusive process toward particular amino acid composition, net charge, and more! Furthermore, you can sample proteins from a family of sequences or even train a small sequence to function classifier to guide generation toward desired sequences.
|
415 |
![fig1](http://files.ipd.uw.edu/pub/sequence_diffusion/figs/diffusion_landscape.png)
|
416 |
|
|
|
428 |
|
429 |
with gr.Row().style(equal_height=False):
|
430 |
with gr.Column():
|
431 |
+
with gr.Tabs():
|
432 |
+
with gr.TabItem("Inputs"):
|
433 |
+
gr.Markdown("""## INPUTS""")
|
434 |
+
gr.Markdown("""#### Start Sequence
|
435 |
+
Specify the protein length for complete unconditional generation, or scaffold a motif (or your name) using the custom sequence input""")
|
436 |
+
seq_opt = gr.Radio(["protein length","custom sequence"], label="How would you like to specify the starting sequence?", value='protein length')
|
437 |
+
|
438 |
+
sequence = gr.Textbox(label="custom sequence", lines=1, placeholder='AMINO ACIDS: A,C,D,E,F,G,H,I,K,L,M,N,P,Q,R,S,T,V,W,Y\n MASK TOKEN: X', visible=False)
|
439 |
+
seq_len = gr.Slider(minimum=5.0, maximum=250.0, label="protein length", value=100, visible=True)
|
440 |
+
|
441 |
+
seq_opt.change(fn=toggle_seq_input,
|
442 |
+
inputs=[seq_opt],
|
443 |
+
outputs=[seq_len, sequence],
|
444 |
+
queue=False)
|
445 |
+
|
446 |
+
gr.Markdown("""### Optional Parameters""")
|
447 |
+
with gr.Accordion(label='Secondary Structure',open=True):
|
448 |
+
gr.Markdown("""Try changing the sliders or inputing explicit secondary structure conditioning for each residue""")
|
449 |
+
sec_str_opt = gr.Radio(["sliders","explicit"], label="How would you like to specify secondary structure?", value='sliders')
|
450 |
+
|
451 |
+
secondary_structure = gr.Textbox(label="secondary structure", lines=1, placeholder='HELIX = H STRAND = S LOOP = L MASK = X(must be the same length as input sequence)', visible=False)
|
452 |
+
|
453 |
+
with gr.Column():
|
454 |
+
helix_bias = gr.Slider(minimum=0.0, maximum=0.05, label="helix bias", visible=True)
|
455 |
+
strand_bias = gr.Slider(minimum=0.0, maximum=0.05, label="strand bias", visible=True)
|
456 |
+
loop_bias = gr.Slider(minimum=0.0, maximum=0.20, label="loop bias", visible=True)
|
457 |
+
|
458 |
+
sec_str_opt.change(fn=toggle_secondary_structure,
|
459 |
+
inputs=[sec_str_opt],
|
460 |
+
outputs=[helix_bias,strand_bias,loop_bias,secondary_structure],
|
461 |
+
queue=False)
|
462 |
+
|
463 |
+
with gr.Accordion(label='Amino Acid Compositional Bias',open=False):
|
464 |
+
gr.Markdown("""Bias sequence composition for particular amino acids by specifying the one letter code followed by the fraction to bias. This can be input as a list for example: W0.2,E0.1""")
|
465 |
+
with gr.Row():
|
466 |
+
aa_bias = gr.Textbox(label="aa bias", lines=1, placeholder='specify one letter AA and fraction to bias, for example W0.1 or M0.1,K0.1' )
|
467 |
+
aa_bias_potential = gr.Textbox(label="aa bias scale", lines=1, placeholder='AA Bias potential scale (recomended range 1.0-5.0)')
|
468 |
+
|
469 |
+
'''
|
470 |
+
with gr.Accordion(label='Charge Bias',open=False):
|
471 |
+
gr.Markdown("""Bias for a specified net charge at a particular pH using the boxes below""")
|
472 |
+
with gr.Row():
|
473 |
+
target_charge = gr.Textbox(label="net charge", lines=1, placeholder='net charge to target')
|
474 |
+
target_ph = gr.Textbox(label="pH", lines=1, placeholder='pH at which net charge is desired')
|
475 |
+
charge_potential = gr.Textbox(label="charge potential scale", lines=1, placeholder='charge potential scale (recomended range 1.0-5.0)')
|
476 |
+
'''
|
477 |
+
|
478 |
+
with gr.Accordion(label='Hydrophobic Bias',open=False):
|
479 |
+
gr.Markdown("""Bias for or against hydrophobic composition, to get more soluble proteins, bias away with a negative target score (ex. -5)""")
|
480 |
+
with gr.Row():
|
481 |
+
hydrophobic_target_score = gr.Textbox(label="hydrophobic score", lines=1, placeholder='hydrophobic score to target (negative score is good for solublility)')
|
482 |
+
hydrophobic_potential = gr.Textbox(label="hydrophobic potential scale", lines=1, placeholder='hydrophobic potential scale (recomended range 1.0-2.0)')
|
483 |
+
|
484 |
+
with gr.Accordion(label='Diffusion Params',open=False):
|
485 |
+
gr.Markdown("""Increasing T to more steps can be helpful for harder design challenges, sampling from different distributions can change the sequence and structural composition""")
|
486 |
+
with gr.Row():
|
487 |
+
num_steps = gr.Textbox(label="T", lines=1, placeholder='number of diffusion steps (25 or less will speed things up)')
|
488 |
+
noise = gr.Dropdown(['normal','gmm2 [-1,1]','gmm3 [-1,0,1]'], label='noise type', value='normal')
|
489 |
|
490 |
+
with gr.TabItem("Motif Selection"):
|
491 |
+
|
492 |
+
gr.Markdown("""### Motif Selection Preview""")
|
493 |
+
gr.Markdown('Contigs explained: to grab residues (seq and str) on a pdb chain you will provide the chain letter followed by a range of residues as indexed in the pdb file for example (A3-10) is the syntax to select residues 3-10 on chain A (the chain always needs to be specified). To add diffused residues to either side of this motif you can specify a range or discrete value without a chain letter infront. To add 15 residues before the motif and 20-30 residues (randomly sampled) after use the following syntax: 15,A3-10,20-30 commas are used to separate regions selected from the pdb and designed (diffused) resiudes which will be added. ')
|
494 |
+
pdb_id_code = gr.Textbox(label="PDB ID", lines=1, placeholder='INPUT PDB ID TO FETCH (ex. 1DPX)', visible=True)
|
495 |
+
contigs = gr.Textbox(label="contigs", lines=1, placeholder='specify contigs to grab particular residues from pdb ()', visible=True)
|
496 |
+
gr.Markdown('Using the same contig syntax, seq or str of input motif residues can be masked, allowing the model to hold strucutre fixed and design sequence or vice-versa')
|
497 |
+
with gr.Row():
|
498 |
+
seq_mask = gr.Textbox(label='seq mask',lines=1,placeholder='input residues to mask sequence')
|
499 |
+
str_mask = gr.Textbox(label='str mask',lines=1,placeholder='input residues to mask structure')
|
500 |
+
preview_viewer = gr.HTML()
|
501 |
+
rewrite_pdb = gr.File(label='PDB file')
|
502 |
+
preview_btn = gr.Button("Preview Motif")
|
503 |
+
|
504 |
+
with gr.TabItem("MSA to PSSM"):
|
505 |
+
gr.Markdown("""### MSA to PSSM Generation""")
|
506 |
+
gr.Markdown('input either an MSA or PSSM to guide the model toward generating samples within your family of interest')
|
507 |
+
with gr.Row():
|
508 |
+
fasta_msa = gr.File(label='MSA')
|
509 |
+
input_pssm = gr.File(label='PSSM (.csv)')
|
510 |
+
pssm = gr.File(label='Generated PSSM')
|
511 |
+
pssm_view = gr.Plot(label='PSSM Viewer')
|
512 |
+
pssm_gen_btn = gr.Button("Generate PSSM")
|
513 |
+
|
|
|
|
|
514 |
|
515 |
btn = gr.Button("GENERATE")
|
516 |
|
|
|
528 |
|
529 |
gr.Markdown("""### Don't know where to get started? Click on an example below to try it out!""")
|
530 |
gr.Examples(
|
531 |
+
[["","125",0.0,0.0,0.2,"","","","20","normal",'','','',None,'','',None],
|
532 |
+
["","100",0.0,0.0,0.0,"","W0.2","2","20","normal",'','','',None,'','',None],
|
533 |
+
["","100",0.0,0.0,0.0,
|
534 |
+
"XXHHHHHHHHHXXXXXXXHHHHHHHHHXXXXXXXHHHHHHHHXXXXSSSSSSSSSSSXXXXXXXXSSSSSSSSSSSSXXXXXXXSSSSSSSSSXXXXXXX",
|
535 |
+
"","","25","normal",'','','',None,'','',None],
|
536 |
+
["XXXXXXXXXXXXXXXXXXXXXXXXXIPDXXXXXXXXXXXXXXXXXXXXXXPEPSEQXXXXXXXXXXXXXXXXXXXXXXXXXXIPDXXXXXXXXXXXXXXXXXXX",
|
537 |
+
"",0.0,0.0,0.0,"","","","25","normal",'','','',None,'','',None],
|
538 |
+
["","",0.0,0.0,0.0,"","","","25","normal",'','',
|
539 |
+
'9,D10-11,8,D20-20,4,D25-35,65,D101-101,2,D104-105,8,D114-116,15,D132-138,6,D145-145,2,D148-148,12,D161-161,3',
|
540 |
+
'./tmp/PSSM_lysozyme.csv',
|
541 |
+
'D25-25,D27-31,D33-35,D132-137',
|
542 |
+
'D26-26','./tmp/150l.pdb']
|
543 |
+
|
544 |
+
],
|
545 |
inputs=[sequence,
|
546 |
seq_len,
|
547 |
helix_bias,
|
|
|
556 |
num_steps,
|
557 |
noise,
|
558 |
hydrophobic_target_score,
|
559 |
+
hydrophobic_potential,
|
560 |
+
contigs,
|
561 |
+
pssm,
|
562 |
+
seq_mask,
|
563 |
+
str_mask,
|
564 |
+
rewrite_pdb],
|
565 |
outputs=[output_seq,
|
566 |
output_pdb,
|
567 |
output_viewer,
|
568 |
plddt_plot],
|
569 |
fn=protein_diffusion_model,
|
570 |
)
|
571 |
+
|
572 |
+
preview_btn.click(get_motif_preview,[pdb_id_code, contigs],[preview_viewer, rewrite_pdb])
|
573 |
+
|
574 |
+
pssm_gen_btn.click(get_pssm,[fasta_msa,input_pssm],[pssm_view, pssm])
|
575 |
+
|
576 |
btn.click(protein_diffusion_model,
|
577 |
[sequence,
|
578 |
seq_len,
|
|
|
588 |
num_steps,
|
589 |
noise,
|
590 |
hydrophobic_target_score,
|
591 |
+
hydrophobic_potential,
|
592 |
+
contigs,
|
593 |
+
pssm,
|
594 |
+
seq_mask,
|
595 |
+
str_mask,
|
596 |
+
rewrite_pdb],
|
597 |
[output_seq,
|
598 |
output_pdb,
|
599 |
output_viewer,
|
|
|
602 |
demo.queue()
|
603 |
demo.launch(debug=True)
|
604 |
|
605 |
+
|
606 |
+
|
tmp/150l.pdb
ADDED
The diff for this file is too large to render.
See raw diff
|
|
tmp/PSSM_lysozyme.csv
ADDED
@@ -0,0 +1,164 @@
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
1 |
+
7.431874483897604917e-03,1.445086705202312067e-03,6.399669694467382229e-03,1.011560693641618512e-02,4.128819157720891621e-04,8.876961189099917202e-03,1.445086705202312111e-02,1.857968620974401229e-03,1.238645747316267486e-03,2.477291494632534972e-03,6.193228736581337865e-03,7.844756399669694513e-03,3.922378199834847257e-02,2.064409578860445810e-04,2.683732452518579770e-03,2.931461601981833268e-02,1.568951279933938903e-02,0.000000000000000000e+00,1.032204789430222905e-03,5.367464905037159541e-03,0.000000000000000000e+00
|
2 |
+
6.585466556564822938e-02,8.402146985962015424e-02,6.647398843930635293e-02,5.862923203963666535e-02,1.032204789430223035e-02,8.484723369116432823e-02,7.184145334434351160e-02,5.986787778695293501e-03,1.197357555739058700e-02,2.642444260941370637e-02,4.521056977704376867e-02,1.560693641618497163e-01,9.083402146985962433e-03,6.399669694467382229e-03,4.128819157720891621e-03,4.190751445086705190e-02,5.057803468208092734e-02,1.651527663088356648e-03,4.954582989265069945e-03,1.362510322047894365e-02,0.000000000000000000e+00
|
3 |
+
4.355904211395540682e-02,1.651527663088356648e-03,6.193228736581337431e-04,1.651527663088356648e-03,1.114781172584640781e-02,2.477291494632534972e-03,2.270850536746490608e-03,4.541701073492981217e-03,8.257638315441783242e-04,1.220066061106523519e-01,5.295210569777043519e-01,1.114781172584640781e-02,1.114781172584640781e-02,3.158546655656482155e-02,2.270850536746490608e-03,4.541701073492981217e-03,1.651527663088356648e-02,1.857968620974401229e-03,3.922378199834847257e-03,8.980181668042939991e-02,0.000000000000000000e+00
|
4 |
+
5.470685383980181810e-02,1.791907514450866989e-01,4.748142031379025581e-03,8.257638315441783242e-03,4.128819157720891621e-03,4.459124690338563124e-02,4.211395540875309540e-02,3.509496284062758095e-03,2.683732452518579770e-03,1.248967795210569748e-01,5.408753096614368067e-02,1.810487200660610974e-01,1.878612716763005883e-02,4.397192402972750075e-02,2.064409578860445810e-03,1.341866226259289842e-02,3.303055326176713297e-02,4.128819157720891621e-04,4.913294797687861593e-02,5.016515276630883341e-02,0.000000000000000000e+00
|
5 |
+
1.139554087530966209e-01,3.385631709331131389e-02,3.612716763005780624e-02,1.222130470685384024e-01,3.096614368290668932e-03,5.842279108175062186e-02,2.989265070189925932e-01,1.052848885218827385e-02,5.573905862923203905e-03,5.573905862923203905e-03,1.445086705202312111e-02,1.129232039636663965e-01,2.064409578860445810e-03,8.257638315441783242e-04,1.796036333608587790e-02,5.161023947151114483e-02,2.725020644095788730e-02,0.000000000000000000e+00,2.477291494632534972e-03,1.279933938893476446e-02,0.000000000000000000e+00
|
6 |
+
1.424442609413707761e-02,8.175061932287365496e-02,5.780346820809248269e-03,6.151940545004128819e-02,1.651527663088356648e-03,2.563996696944673692e-01,1.614368290668868611e-01,1.651527663088356648e-03,1.341866226259289842e-02,4.232039636663913890e-02,8.195706028075970540e-02,3.447563996696944438e-02,9.393063583815028372e-02,1.052848885218827385e-02,1.445086705202312067e-03,2.972749793559041967e-02,1.981833195706027978e-02,7.018992568125516189e-03,8.051197357555739745e-03,1.197357555739058700e-02,0.000000000000000000e+00
|
7 |
+
3.922378199834847257e-03,2.890173410404624135e-03,2.064409578860445810e-04,4.128819157720891621e-04,2.064409578860445810e-04,2.270850536746490608e-03,4.541701073492981217e-03,1.032204789430222905e-03,4.128819157720891621e-04,2.630057803468208166e-01,5.951692815854665586e-01,1.176713459950454177e-02,3.096614368290668932e-03,2.683732452518579770e-03,8.257638315441783242e-04,2.064409578860445810e-03,1.114781172584640781e-02,8.257638315441783242e-04,8.257638315441783242e-04,3.963666391412055956e-02,0.000000000000000000e+00
|
8 |
+
8.753096614368290063e-02,1.139554087530966209e-01,1.589595375722543252e-02,3.715937241948802459e-03,2.270850536746490608e-03,2.477291494632535146e-02,8.959537572254334947e-02,6.606110652353426593e-03,4.541701073492981217e-03,1.333608587943848067e-01,1.754748142031379091e-02,3.014037985136250875e-01,2.208918249380677212e-02,3.303055326176713297e-03,1.857968620974401229e-03,2.725020644095788730e-02,4.397192402972750075e-02,1.238645747316267486e-03,2.477291494632534972e-03,4.355904211395540682e-02,0.000000000000000000e+00
|
9 |
+
5.924855491329479584e-02,2.464905037159372536e-01,1.961189099917423628e-02,2.415359207266721750e-02,2.477291494632534972e-03,4.582989265070189916e-02,7.638315441783649629e-02,1.857968620974401186e-02,1.961189099917423628e-02,1.215937241948802650e-01,5.718414533443435394e-02,9.723369116432700743e-02,5.573905862923203905e-03,3.158546655656482155e-02,2.890173410404624135e-03,2.497935590421139496e-02,1.610239471511147949e-02,2.477291494632534972e-03,2.291494632535094958e-02,4.438480594549958774e-02,0.000000000000000000e+00
|
10 |
+
1.568951279933938903e-02,4.335260115606935985e-03,5.450041288191577460e-02,4.149463253509496075e-01,2.683732452518579770e-03,6.399669694467382229e-03,7.597027250206440929e-02,4.954582989265069945e-03,3.189512799339389026e-01,2.064409578860445810e-04,1.445086705202312067e-03,2.890173410404624135e-03,1.238645747316267486e-03,1.527663088356730030e-02,1.032204789430222905e-03,1.403798513625103238e-02,2.477291494632534972e-03,3.509496284062758095e-03,1.837324525185796836e-02,6.193228736581337431e-04,0.000000000000000000e+00
|
11 |
+
1.032204789430222905e-03,1.651527663088356648e-03,1.032204789430222905e-03,6.193228736581337431e-04,6.193228736581337431e-04,1.032204789430222905e-03,9.475639966969446881e-01,3.303055326176713297e-03,2.064409578860445810e-04,0.000000000000000000e+00,4.128819157720891621e-04,1.857968620974401229e-03,0.000000000000000000e+00,0.000000000000000000e+00,6.193228736581337431e-04,1.651527663088356648e-03,1.445086705202312067e-03,2.064409578860445810e-04,4.128819157720891621e-04,1.032204789430222905e-03,0.000000000000000000e+00
|
12 |
+
1.321222130470685319e-02,4.128819157720891621e-03,3.096614368290668932e-03,1.238645747316267573e-02,6.193228736581337431e-04,2.064409578860445810e-04,4.748142031379025581e-03,9.077208918249380920e-01,6.193228736581337431e-04,6.193228736581337431e-04,0.000000000000000000e+00,3.303055326176713297e-03,4.128819157720891621e-04,6.193228736581337431e-04,4.128819157720891621e-04,1.259289843104871923e-02,1.445086705202312067e-03,0.000000000000000000e+00,6.193228736581337431e-04,1.032204789430222905e-03,0.000000000000000000e+00
|
13 |
+
3.715937241948802459e-03,6.213872832369941868e-02,1.465730800990916634e-02,7.225433526011560553e-03,6.440957886044591796e-02,6.606110652353426593e-03,5.966143682906688978e-02,1.527663088356730030e-02,1.651527663088356648e-03,4.892650701899256549e-02,1.568951279933938903e-01,6.131296449215524469e-02,2.621800165152766288e-02,1.199421965317919031e-01,2.270850536746490608e-03,1.403798513625103238e-02,9.909165978530139890e-03,1.321222130470685319e-02,9.723369116432700743e-02,1.822873658133773722e-01,0.000000000000000000e+00
|
14 |
+
6.193228736581337865e-03,4.068951279933938903e-01,1.527663088356730030e-02,9.083402146985962433e-03,6.399669694467382229e-03,7.225433526011560553e-03,4.376548307184145031e-02,3.303055326176713297e-03,2.270850536746490608e-03,2.291494632535094958e-02,3.303055326176713297e-03,1.901321222130470667e-01,7.225433526011560553e-03,2.270850536746490608e-03,3.096614368290668932e-03,4.417836498761354425e-02,4.335260115606935985e-03,8.257638315441783242e-04,2.064409578860445810e-03,1.793971924029727494e-01,0.000000000000000000e+00
|
15 |
+
4.108175061932287098e-02,2.291494632535094958e-02,7.555739058629232230e-02,4.376548307184145031e-02,6.399669694467382229e-03,1.692815854665565695e-02,3.736581337737407416e-02,2.023121387283237024e-02,3.468208092485548788e-02,4.128819157720891621e-03,3.381502890173410658e-01,2.518579686209743845e-02,3.715937241948802459e-03,2.146985962014863816e-02,4.273327828241123283e-02,5.883567299752270885e-02,3.220478943022295898e-02,0.000000000000000000e+00,1.465730800990916460e-01,4.128819157720891621e-03,0.000000000000000000e+00
|
16 |
+
2.559867877786952892e-02,6.172584640792733168e-02,2.208918249380677212e-02,1.878612716763005883e-02,2.848885218827415522e-02,3.282411230388108947e-02,2.149050371593724251e-01,3.922378199834847257e-03,8.567299752270850222e-02,1.238645747316267573e-02,1.507018992568125507e-02,2.405037159372419575e-01,9.083402146985962433e-03,4.211395540875309540e-02,1.445086705202312067e-03,4.046242774566474049e-02,7.163501238645747504e-02,4.128819157720891621e-03,2.250206440957885912e-02,3.323699421965317646e-02,0.000000000000000000e+00
|
17 |
+
1.098265895953757232e-01,7.638315441783650149e-03,4.128819157720891621e-04,2.064409578860445810e-04,9.289843104872005930e-03,2.270850536746490608e-03,2.890173410404624135e-03,3.509496284062758095e-03,0.000000000000000000e+00,2.118084227910817519e-01,3.117258464079273456e-02,8.670520231213871970e-03,2.002477291494632675e-02,2.270850536746490608e-03,2.770437654830718577e-01,1.300578034682080969e-02,2.807597027250206476e-02,4.128819157720891621e-03,6.812551610239471825e-03,2.485549132947976747e-01,0.000000000000000000e+00
|
18 |
+
6.193228736581337431e-04,4.128819157720891621e-04,8.257638315441783242e-04,4.128819157720891621e-04,4.128819157720891621e-04,6.193228736581337431e-04,4.128819157720891621e-04,1.857968620974401229e-03,1.238645747316267486e-03,6.193228736581337431e-04,8.257638315441783242e-04,1.651527663088356648e-03,2.064409578860445810e-04,2.270850536746490608e-03,1.238645747316267486e-03,2.064409578860445810e-03,6.193228736581337431e-04,0.000000000000000000e+00,9.663501238645747504e-01,1.238645747316267486e-03,0.000000000000000000e+00
|
19 |
+
1.692815854665565695e-02,1.106523534269198972e-01,4.644921552436002965e-02,4.128819157720892141e-02,6.193228736581337431e-04,6.998348472336911319e-02,4.500412881915771823e-02,2.477291494632534972e-03,2.683732452518579684e-02,2.704376548307184033e-02,2.206853839801816708e-01,2.031379025598678834e-01,1.341866226259289842e-02,1.197357555739058700e-02,2.518579686209743845e-02,9.289843104872005930e-03,5.718414533443435394e-02,1.032204789430223035e-02,1.919900908340214582e-02,3.179190751445086505e-02,0.000000000000000000e+00
|
20 |
+
2.270850536746490608e-03,1.445086705202312067e-03,2.890173410404624135e-03,7.972749793559041898e-01,1.680429397192403085e-01,8.257638315441783242e-04,2.064409578860445810e-04,1.857968620974401229e-03,1.238645747316267486e-03,2.064409578860445810e-03,1.445086705202312067e-03,1.238645747316267486e-03,6.193228736581337431e-04,2.064409578860445810e-04,6.193228736581337431e-04,1.445086705202312067e-03,1.032204789430222905e-03,0.000000000000000000e+00,1.238645747316267486e-03,3.715937241948802459e-03,0.000000000000000000e+00
|
21 |
+
1.672171758876961345e-02,2.477291494632534972e-03,3.922378199834847257e-03,3.096614368290668932e-03,2.477291494632534972e-03,1.981833195706027978e-02,2.890173410404624135e-03,1.094137076796036258e-02,2.116019818331957014e-01,8.876961189099917202e-03,8.464079273327828473e-03,1.094137076796036258e-02,1.032204789430222905e-03,1.032204789430222905e-03,4.170107349298100841e-02,3.160611065235342521e-01,3.150289017341040276e-01,0.000000000000000000e+00,6.193228736581337431e-04,1.300578034682080969e-02,0.000000000000000000e+00
|
22 |
+
9.454995871180842115e-02,5.511973575557390509e-02,9.702725020644096393e-03,3.096614368290668932e-03,8.257638315441783242e-04,2.126341866226259120e-02,1.358381502890173287e-01,1.507018992568125507e-02,3.096614368290668932e-03,5.986787778695293501e-03,4.106110652353426871e-01,4.851362510322047850e-02,2.023121387283237024e-02,3.096614368290668932e-03,1.011560693641618512e-02,1.032204789430223035e-02,3.488852188274153832e-02,4.128819157720891621e-04,2.064409578860445810e-03,1.034269199009083401e-01,0.000000000000000000e+00
|
23 |
+
7.638315441783650149e-03,3.303055326176713297e-03,4.582989265070189916e-02,2.229562345169281562e-02,4.128819157720891621e-04,4.128819157720891621e-03,5.573905862923203905e-03,8.499174236168456353e-01,3.922378199834847257e-03,4.128819157720891621e-04,2.064409578860445810e-03,1.589595375722543252e-02,2.064409578860445810e-04,8.257638315441783242e-04,8.464079273327828473e-03,1.672171758876961345e-02,1.032204789430222905e-03,0.000000000000000000e+00,2.064409578860445810e-04,1.032204789430222905e-03,0.000000000000000000e+00
|
24 |
+
8.876961189099917202e-03,1.052848885218827385e-02,5.264244426094136925e-02,1.032204789430222905e-03,2.064409578860445810e-03,3.096614368290668932e-03,2.270850536746490608e-03,2.270850536746490608e-03,9.021469859620148690e-02,9.723369116432700743e-02,1.001238645747316303e-01,2.072667217175887810e-01,4.128819157720891621e-04,9.124690338563171133e-02,8.051197357555739745e-03,1.238645747316267486e-03,4.335260115606935985e-03,4.748142031379025581e-03,2.710569777043765338e-01,3.406275805119735739e-02,0.000000000000000000e+00
|
25 |
+
5.057803468208092734e-02,2.766308835672997429e-02,7.844756399669694513e-03,4.851362510322047850e-02,3.303055326176713297e-03,1.156069364161849654e-02,1.899256812551610232e-02,3.096614368290668932e-03,5.367464905037159541e-03,2.745664739884393080e-02,2.215111478117258448e-01,6.688687035507845380e-02,6.399669694467382229e-03,4.954582989265069945e-03,3.028488852188274127e-01,1.507018992568125507e-02,2.023121387283237024e-02,1.218001651527663154e-01,8.670520231213871970e-03,2.188274153592072516e-02,0.000000000000000000e+00
|
26 |
+
2.270850536746490608e-03,6.193228736581337431e-04,6.193228736581337431e-04,2.064409578860445810e-04,2.064409578860445810e-04,8.257638315441783242e-04,0.000000000000000000e+00,8.257638315441783242e-04,4.128819157720891621e-03,8.257638315441783242e-04,1.032204789430222905e-03,2.064409578860445810e-04,2.064409578860445810e-04,4.128819157720891621e-04,8.257638315441783242e-04,3.798513625103220465e-02,9.428158546655656114e-01,2.064409578860445810e-04,4.128819157720891621e-04,1.032204789430222905e-03,0.000000000000000000e+00
|
27 |
+
2.312138728323699308e-02,6.193228736581337431e-04,1.445086705202312067e-03,4.128819157720891621e-04,3.303055326176713297e-02,8.257638315441783242e-04,4.128819157720891621e-04,3.612716763005780624e-02,2.064409578860445810e-03,5.332369942196532042e-01,4.789430222956234801e-02,0.000000000000000000e+00,4.128819157720891621e-03,1.492568125516102462e-01,2.064409578860445810e-04,1.238645747316267486e-03,7.844756399669694513e-03,2.064409578860445810e-03,2.270850536746490608e-03,1.507018992568125437e-01,0.000000000000000000e+00
|
28 |
+
1.362510322047894365e-02,2.477291494632534972e-03,0.000000000000000000e+00,6.193228736581337431e-04,7.638315441783650149e-03,4.128819157720891621e-04,4.128819157720891621e-04,9.636663914120561225e-01,0.000000000000000000e+00,0.000000000000000000e+00,2.064409578860445810e-04,1.032204789430222905e-03,2.064409578860445810e-04,8.257638315441783242e-04,8.257638315441783242e-04,1.032204789430222905e-03,0.000000000000000000e+00,4.128819157720891621e-04,2.064409578860445810e-03,1.651527663088356648e-03,0.000000000000000000e+00
|
29 |
+
8.670520231213871970e-03,4.954582989265069945e-03,4.128819157720891621e-04,1.857968620974401229e-03,1.630883567299752299e-02,0.000000000000000000e+00,1.445086705202312067e-03,7.638315441783650149e-03,3.096614368290668932e-03,3.755161023947151122e-01,1.238645747316267486e-03,1.445086705202312067e-03,6.193228736581337431e-04,2.270850536746490608e-02,8.257638315441783242e-04,6.193228736581337431e-04,6.606110652353426593e-03,2.497935590421139496e-02,1.988026424442609352e-01,3.193641618497110035e-01,0.000000000000000000e+00
|
30 |
+
2.064409578860445810e-04,8.257638315441783242e-04,4.128819157720891621e-04,1.445086705202312067e-03,1.032204789430222905e-03,1.032204789430222905e-03,2.064409578860445810e-04,9.820396366639141394e-01,0.000000000000000000e+00,5.367464905037159541e-03,4.128819157720891621e-04,2.064409578860445810e-04,0.000000000000000000e+00,0.000000000000000000e+00,4.128819157720891621e-04,2.064409578860445810e-04,6.193228736581337431e-04,0.000000000000000000e+00,0.000000000000000000e+00,8.257638315441783242e-04,0.000000000000000000e+00
|
31 |
+
6.606110652353426593e-03,2.640379851362510411e-01,4.872006606110652199e-02,4.128819157720891621e-03,6.812551610239471825e-03,3.303055326176713297e-03,1.032204789430222905e-03,1.032204789430222905e-03,4.950454170107349561e-01,9.909165978530139890e-03,2.683732452518579770e-03,1.114781172584640781e-02,1.032204789430222905e-03,6.771263418662262779e-02,1.238645747316267486e-03,2.683732452518579770e-03,1.362510322047894365e-02,5.367464905037159541e-03,2.394715111478117400e-02,2.683732452518579770e-03,0.000000000000000000e+00
|
32 |
+
9.702725020644096393e-03,1.156069364161849654e-02,3.490916597853013781e-01,6.606110652353426593e-03,1.011560693641618512e-02,2.477291494632534972e-03,2.477291494632534972e-03,3.096614368290668932e-03,6.193228736581337431e-04,2.683732452518579684e-02,4.694467382328654237e-01,2.642444260941370637e-02,8.051197357555739745e-03,8.051197357555739745e-03,1.445086705202312067e-03,1.651527663088356648e-03,8.257638315441783242e-03,4.128819157720891621e-04,3.303055326176713297e-03,5.161023947151115177e-03,0.000000000000000000e+00
|
33 |
+
9.496284062758051162e-03,7.844756399669694513e-03,7.844756399669694513e-03,3.137902559867877805e-02,1.341866226259289842e-02,6.193228736581337865e-03,3.096614368290668759e-02,2.518579686209743845e-02,3.922378199834847257e-03,2.241948802642444172e-01,4.318744838976052991e-01,7.018992568125516189e-03,1.094137076796036258e-02,4.541701073492981217e-03,1.300578034682080969e-02,5.986787778695293501e-03,2.477291494632534972e-03,4.128819157720891621e-04,5.780346820809248269e-03,1.174649050371593673e-01,0.000000000000000000e+00
|
34 |
+
2.807597027250206476e-02,4.851362510322047850e-02,1.610239471511147949e-02,1.711395540875309540e-01,5.161023947151115177e-03,3.612716763005780624e-02,8.030553261767134354e-02,3.612716763005780624e-02,9.083402146985962433e-03,3.612716763005780624e-02,5.656482246077621651e-02,4.170107349298100841e-02,3.096614368290668932e-03,3.922378199834847257e-03,3.261767134599504597e-02,4.046242774566474049e-02,2.095375722543352526e-01,8.257638315441783242e-04,2.890173410404624135e-03,3.303055326176713297e-02,0.000000000000000000e+00
|
35 |
+
7.328654004954582302e-02,3.241123038810900248e-02,3.137902559867877805e-02,1.950867052023121384e-01,7.225433526011560553e-03,1.940545004128819279e-02,1.385218827415359288e-01,3.117258464079273456e-02,8.257638315441783242e-03,1.486374896779520983e-02,8.257638315441783242e-03,1.767134599504541770e-01,2.064409578860445810e-03,1.238645747316267486e-03,3.488852188274153832e-02,1.816680429397192487e-02,1.548307184145334379e-02,1.238645747316267486e-03,2.064409578860445810e-03,1.961189099917423628e-02,0.000000000000000000e+00
|
36 |
+
2.374071015689512704e-02,7.184145334434351160e-02,4.913294797687861593e-02,8.546655656482246566e-02,2.064409578860445810e-03,1.878612716763005883e-02,5.305532617671346318e-02,8.092485549132948097e-02,1.486374896779520983e-02,1.279933938893476446e-02,1.238645747316267573e-02,2.208918249380677212e-02,2.477291494632534972e-03,2.064409578860445810e-03,1.589595375722543252e-02,1.240710156895128008e-01,2.436003303055326100e-02,1.424442609413707761e-02,9.083402146985962433e-03,1.672171758876961345e-02,0.000000000000000000e+00
|
37 |
+
2.415359207266721750e-02,2.807597027250206476e-02,1.052848885218827385e-02,5.615194054500412951e-02,1.032204789430222905e-03,7.638315441783650149e-03,5.016515276630883341e-02,5.759702725020644093e-02,8.876961189099917202e-03,7.638315441783650149e-03,8.051197357555739745e-03,5.057803468208092734e-02,1.857968620974401229e-03,3.509496284062758095e-03,1.284062758051197350e-01,5.780346820809248269e-03,1.300578034682080969e-02,2.477291494632534972e-03,8.670520231213871970e-03,6.399669694467382229e-03,0.000000000000000000e+00
|
38 |
+
2.250206440957885912e-02,1.878612716763005883e-02,1.176713459950454177e-02,1.707266721717588809e-01,6.193228736581337431e-04,8.257638315441783242e-03,3.117258464079273456e-02,1.837324525185796836e-02,4.335260115606935985e-03,2.374071015689512704e-02,2.085053674649050420e-02,1.300578034682080969e-02,3.509496284062758095e-03,3.303055326176713297e-03,1.630883567299752299e-02,5.429397192402972416e-02,1.032204789430223035e-02,2.064409578860445810e-03,5.367464905037159541e-03,8.876961189099917202e-03,0.000000000000000000e+00
|
39 |
+
2.580511973575557241e-02,2.745664739884393080e-02,6.399669694467382229e-03,4.232039636663913890e-02,1.445086705202312067e-03,9.702725020644096393e-03,6.585466556564822938e-02,1.837324525185796836e-02,2.890173410404624135e-03,1.114781172584640781e-02,7.679603633360858328e-02,1.589595375722543252e-02,9.496284062758051162e-03,4.541701073492981217e-03,1.034269199009083401e-01,1.238645747316267573e-02,1.610239471511147949e-02,1.238645747316267486e-03,7.431874483897604917e-03,6.193228736581337865e-03,0.000000000000000000e+00
|
40 |
+
1.672171758876961345e-02,1.796036333608587790e-02,4.087530966143682748e-02,4.397192402972750075e-02,1.445086705202312067e-03,1.052848885218827385e-02,1.777456647398844014e-01,3.447563996696944438e-02,3.922378199834847257e-03,1.218001651527663050e-02,1.073492981007431908e-02,2.270850536746490608e-02,5.986787778695293501e-03,4.748142031379025581e-03,3.592072667217175580e-02,1.197357555739058700e-02,1.032204789430223035e-02,2.064409578860445810e-03,4.954582989265069945e-03,5.986787778695293501e-03,0.000000000000000000e+00
|
41 |
+
6.151940545004128819e-02,1.321222130470685319e-02,7.638315441783650149e-03,2.477291494632535146e-02,2.890173410404624135e-03,1.094137076796036258e-02,4.376548307184145031e-02,1.940545004128819279e-02,2.952105697770437617e-02,2.043765483071841374e-02,1.259289843104871923e-02,8.464079273327828473e-03,1.238645747316267486e-03,1.238645747316267573e-02,1.383154417836498715e-02,7.844756399669694513e-03,7.018992568125516189e-03,3.303055326176713297e-03,5.161023947151114483e-02,1.094137076796036258e-02,0.000000000000000000e+00
|
42 |
+
6.915772089182493920e-02,7.225433526011560553e-03,4.541701073492981217e-03,1.300578034682080969e-02,1.651527663088356648e-03,4.335260115606935985e-03,3.303055326176713297e-02,5.573905862923203905e-03,5.573905862923203905e-03,1.775392237819983440e-02,1.094137076796036258e-02,7.225433526011560553e-03,2.270850536746490608e-03,8.051197357555739745e-03,1.011560693641618512e-02,1.218001651527663050e-02,1.197357555739058700e-02,8.257638315441783242e-03,1.672171758876961345e-02,7.431874483897604917e-03,0.000000000000000000e+00
|
43 |
+
1.238645747316267573e-02,1.383154417836498715e-02,1.094137076796036258e-02,1.197357555739058700e-02,1.651527663088356648e-03,5.367464905037159541e-03,1.919900908340214582e-02,1.052848885218827385e-02,4.335260115606935985e-03,1.424442609413707761e-02,2.559867877786952892e-02,4.582989265070189916e-02,2.270850536746490608e-03,8.257638315441783242e-03,6.399669694467382229e-03,3.096614368290668932e-03,4.128819157720891621e-03,1.238645747316267486e-03,1.156069364161849654e-02,5.986787778695293501e-03,0.000000000000000000e+00
|
44 |
+
1.259289843104871923e-02,9.083402146985962433e-03,4.954582989265069945e-03,1.610239471511147949e-02,8.257638315441783242e-04,5.780346820809248269e-03,2.023121387283237024e-02,7.638315441783650149e-03,2.270850536746490608e-03,9.909165978530139890e-03,1.589595375722543252e-02,8.464079273327828473e-03,4.335260115606935985e-03,3.509496284062758095e-03,8.257638315441783242e-03,3.055326176713460060e-02,3.096614368290668932e-03,1.445086705202312067e-03,6.812551610239471825e-03,1.300578034682080969e-02,0.000000000000000000e+00
|
45 |
+
1.073492981007431908e-02,3.922378199834847257e-03,4.954582989265069945e-03,8.257638315441783242e-03,4.128819157720891621e-04,5.367464905037159541e-03,7.018992568125516363e-02,2.250206440957885912e-02,3.715937241948802459e-03,8.876961189099917202e-03,6.812551610239471825e-03,3.303055326176713297e-03,1.445086705202312067e-03,3.509496284062758095e-03,2.064409578860445810e-03,3.096614368290668932e-03,4.748142031379025581e-03,2.064409578860445810e-03,4.335260115606935985e-03,7.018992568125516189e-03,0.000000000000000000e+00
|
46 |
+
1.672171758876961345e-02,4.335260115606935985e-03,2.890173410404624135e-03,2.270850536746490608e-03,1.238645747316267486e-03,2.683732452518579770e-03,1.238645747316267486e-03,4.748142031379025581e-03,3.715937241948802459e-03,7.844756399669694513e-03,9.702725020644095699e-02,2.064409578860445810e-03,6.606110652353426593e-03,2.270850536746490608e-03,3.509496284062758095e-03,2.890173410404624135e-03,2.064409578860445810e-03,1.032204789430222905e-03,1.176713459950454177e-02,7.431874483897604917e-03,0.000000000000000000e+00
|
47 |
+
6.193228736581337865e-03,2.270850536746490608e-03,9.496284062758051162e-03,8.298926507018992982e-02,1.238645747316267486e-03,3.303055326176713297e-03,5.986787778695293501e-03,1.341866226259289842e-02,8.257638315441783242e-04,1.032204789430223035e-02,8.051197357555739745e-03,1.651527663088356648e-03,1.651527663088356648e-03,1.445086705202312067e-03,2.683732452518579770e-03,1.651527663088356648e-02,2.890173410404624135e-03,8.257638315441783242e-04,2.477291494632534972e-03,5.367464905037159541e-03,0.000000000000000000e+00
|
48 |
+
1.259289843104871923e-02,7.431874483897604917e-03,6.399669694467382229e-03,4.335260115606935985e-03,1.032204789430222905e-03,7.225433526011560553e-03,1.197357555739058700e-02,4.335260115606935985e-03,4.335260115606935985e-03,2.477291494632534972e-03,7.018992568125516189e-03,4.582989265070189916e-02,5.367464905037159541e-03,5.986787778695293501e-03,1.321222130470685319e-02,6.399669694467382229e-03,4.748142031379025581e-03,9.289843104872005930e-03,2.601156069364161938e-02,4.128819157720891621e-03,0.000000000000000000e+00
|
49 |
+
4.128819157720892141e-02,4.748142031379025581e-03,8.876961189099917202e-03,2.312138728323699308e-02,1.651527663088356648e-03,1.630883567299752299e-02,1.424442609413707761e-02,6.193228736581337865e-03,5.161023947151115177e-03,3.509496284062758095e-03,1.403798513625103238e-02,4.335260115606935985e-03,7.844756399669694513e-03,2.064409578860445810e-03,1.279933938893476446e-02,1.362510322047894365e-02,9.496284062758051162e-03,1.445086705202312067e-03,9.702725020644096393e-03,5.573905862923203905e-03,0.000000000000000000e+00
|
50 |
+
7.638315441783650149e-03,3.922378199834847257e-03,4.954582989265069945e-03,1.754748142031379091e-02,2.477291494632534972e-03,9.289843104872005930e-03,7.844756399669694513e-03,8.876961189099917202e-03,1.713459950454170044e-02,5.739058629232039743e-02,2.394715111478117400e-02,1.135425268373245304e-02,6.399669694467382229e-03,1.507018992568125507e-02,3.096614368290668932e-03,1.156069364161849654e-02,4.748142031379025581e-03,5.161023947151115177e-03,2.786952931461602126e-02,4.149463253509496491e-02,0.000000000000000000e+00
|
51 |
+
5.573905862923203905e-03,1.857968620974401229e-03,8.051197357555739745e-03,1.816680429397192487e-02,1.857968620974401229e-03,8.464079273327828473e-03,2.208918249380677212e-02,2.341040462427745605e-01,4.541701073492981217e-03,1.486374896779520983e-02,1.052848885218827385e-02,9.702725020644096393e-03,4.541701073492981217e-03,5.573905862923203905e-03,3.303055326176713297e-03,9.496284062758051162e-03,4.128819157720891621e-03,1.445086705202312067e-03,7.844756399669694513e-03,2.229562345169281562e-02,0.000000000000000000e+00
|
52 |
+
3.137902559867877805e-02,6.523534269199009195e-02,7.844756399669694513e-03,2.023121387283237024e-02,3.509496284062758095e-03,2.332782824112304004e-02,2.559867877786952892e-02,1.073492981007431908e-02,1.052848885218827385e-02,8.670520231213871970e-03,4.046242774566474049e-02,3.385631709331131389e-02,8.464079273327828473e-03,6.812551610239471825e-03,2.952105697770437617e-02,1.465730800990916634e-02,1.981833195706027978e-02,8.257638315441783242e-03,1.341866226259289842e-02,1.486374896779520983e-02,0.000000000000000000e+00
|
53 |
+
2.332782824112304004e-02,7.638315441783650149e-03,5.718414533443435394e-02,2.559867877786952892e-02,6.193228736581337431e-04,2.704376548307184033e-02,3.922378199834847257e-02,1.796036333608587790e-02,5.780346820809248269e-03,2.126341866226259120e-02,3.055326176713460060e-02,2.972749793559041967e-02,6.812551610239471825e-03,1.796036333608587790e-02,6.337737407101569354e-02,3.220478943022295898e-02,1.073492981007431908e-02,1.197357555739058700e-02,2.332782824112304004e-02,4.025598678777869699e-02,0.000000000000000000e+00
|
54 |
+
1.878612716763005883e-02,9.289843104872005930e-03,7.431874483897604917e-03,2.436003303055326100e-02,1.837324525185796836e-02,1.052848885218827385e-02,4.603633360858794266e-02,5.862923203963666535e-02,5.780346820809248269e-03,2.952105697770437617e-02,3.117258464079273456e-02,2.456647398843930796e-02,1.238645747316267573e-02,2.146985962014863816e-02,5.883567299752270885e-02,2.167630057803468166e-02,2.415359207266721750e-02,1.135425268373245304e-02,3.777869529314616115e-02,8.298926507018992982e-02,0.000000000000000000e+00
|
55 |
+
2.436003303055326100e-02,1.321222130470685319e-02,1.023947151114781157e-01,3.385631709331131389e-02,8.257638315441783242e-04,2.126341866226259120e-02,5.057803468208092734e-02,1.643270024772914839e-01,8.257638315441783242e-03,1.857968620974401186e-02,1.734104046242774394e-02,4.293971924029727633e-02,7.225433526011560553e-03,9.702725020644096393e-03,2.085053674649050420e-02,3.798513625103220465e-02,5.222956234516928226e-02,8.464079273327828473e-03,1.094137076796036258e-02,5.945499587118083934e-02,0.000000000000000000e+00
|
56 |
+
2.539223781998348542e-02,6.007431874483897677e-02,8.670520231213871970e-03,3.571428571428571230e-02,5.367464905037159541e-03,2.993393889347646664e-02,4.355904211395540682e-02,2.972749793559041898e-01,1.218001651527663050e-02,1.362510322047894365e-02,3.014037985136251013e-02,6.626754748142031637e-02,4.335260115606935985e-03,1.238645747316267573e-02,4.830718414533443500e-02,2.580511973575557241e-02,9.888521882741535540e-02,2.477291494632534972e-03,1.713459950454170044e-02,5.243600330305532575e-02,0.000000000000000000e+00
|
57 |
+
2.621800165152766288e-02,2.539223781998348542e-02,6.399669694467382229e-03,1.527663088356730030e-02,1.899256812551610232e-02,1.424442609413707761e-02,4.541701073492981217e-02,2.384393063583815087e-01,3.715937241948802459e-03,7.431874483897604917e-03,1.754748142031379091e-02,4.479768786127167474e-02,3.303055326176713297e-03,5.986787778695293501e-03,8.071841453344343054e-02,3.261767134599504597e-02,7.968620974401320611e-02,6.193228736581337431e-04,8.670520231213871970e-03,1.895127993393889432e-01,0.000000000000000000e+00
|
58 |
+
1.238645747316267573e-02,1.176713459950454177e-02,1.857968620974401229e-03,1.032204789430223035e-02,4.748142031379025581e-03,6.193228736581337865e-03,1.796036333608587790e-02,5.986787778695293327e-02,2.477291494632534972e-03,4.147398843930635848e-01,1.473988439306358478e-01,9.289843104872005930e-03,9.496284062758051162e-03,3.282411230388108947e-02,4.644921552436002965e-02,3.798513625103220465e-02,1.527663088356730030e-02,1.135425268373245304e-02,2.559867877786952892e-02,5.573905862923204252e-02,0.000000000000000000e+00
|
59 |
+
1.341866226259289842e-02,2.477291494632535146e-02,1.507018992568125507e-02,2.931461601981833268e-02,1.857968620974401229e-03,7.225433526011560553e-03,3.179190751445086505e-02,1.816680429397192487e-02,4.541701073492981217e-03,1.052848885218827385e-02,2.766308835672997429e-02,1.135425268373245304e-02,5.161023947151115177e-03,5.780346820809248269e-03,3.901734104046242907e-02,2.708505367464905111e-01,3.637489677952105427e-01,6.193228736581337431e-04,5.986787778695293501e-03,6.668042939719240336e-02,0.000000000000000000e+00
|
60 |
+
3.881090008257638557e-02,4.872006606110652199e-02,2.188274153592072516e-02,9.372419488026424716e-02,5.367464905037159541e-03,7.617671345995045973e-02,2.018992568125516085e-01,1.052848885218827385e-02,1.568951279933938903e-02,1.610239471511147949e-02,3.984310487200660306e-02,1.568951279933938903e-01,1.878612716763005883e-02,5.780346820809248269e-03,5.099091659785301434e-02,8.113129644921551753e-02,2.270850536746490608e-02,2.270850536746490608e-03,8.876961189099917202e-03,3.839801816680429164e-02,0.000000000000000000e+00
|
61 |
+
1.005367464905037173e-01,4.355904211395540682e-02,1.197357555739058700e-02,2.892237819983484726e-01,3.922378199834847257e-03,4.025598678777869699e-02,2.058216350123864558e-01,1.651527663088356648e-02,1.176713459950454177e-02,1.445086705202312111e-02,1.197357555739058700e-02,3.055326176713460060e-02,9.909165978530139890e-03,3.715937241948802459e-03,2.394715111478117400e-02,6.502890173410404151e-02,2.580511973575557241e-02,3.303055326176713297e-03,8.670520231213871970e-03,4.500412881915771823e-02,0.000000000000000000e+00
|
62 |
+
2.394715111478117400e-02,1.017753922378199782e-01,6.193228736581337865e-03,3.715937241948802372e-02,5.367464905037159541e-03,9.413707679603633416e-02,4.756399669694467147e-01,1.279933938893476446e-02,6.812551610239471825e-03,3.303055326176713297e-02,1.899256812551610232e-02,1.032204789430223035e-02,7.638315441783650149e-03,6.812551610239471825e-03,8.257638315441783242e-03,2.642444260941370637e-02,1.424442609413707761e-02,5.573905862923203905e-03,1.919900908340214582e-02,5.511973575557390509e-02,0.000000000000000000e+00
|
63 |
+
4.114368290668868888e-01,2.043765483071841374e-02,7.844756399669694513e-03,2.394715111478117400e-02,3.984310487200660306e-02,2.126341866226259120e-02,2.126341866226259120e-02,1.197357555739058700e-02,3.922378199834847257e-03,1.110652353426919842e-01,4.252683732452518239e-02,9.083402146985962433e-03,9.909165978530139890e-03,1.176713459950454177e-02,4.128819157720891621e-03,3.901734104046242907e-02,7.638315441783650149e-03,1.011560693641618512e-02,1.238645747316267573e-02,1.568951279933938903e-01,0.000000000000000000e+00
|
64 |
+
2.683732452518579684e-02,6.296449215524360654e-02,5.986787778695293327e-02,1.381090008257638280e-01,5.367464905037159541e-03,3.757225433526011765e-02,2.815854665565648007e-01,8.670520231213871970e-03,7.638315441783650149e-03,3.344343517753922690e-02,5.924855491329479584e-02,1.816680429397192487e-02,5.800990916597852792e-02,2.208918249380677212e-02,6.193228736581337431e-04,3.426919900908340089e-02,3.055326176713460060e-02,8.257638315441783242e-03,4.293971924029727633e-02,3.860445912469033514e-02,0.000000000000000000e+00
|
65 |
+
9.227910817506193575e-02,2.952105697770437617e-02,1.672171758876961345e-02,4.273327828241123283e-02,1.032204789430223035e-02,5.532617671345994859e-02,1.224194880264244389e-01,1.197357555739058700e-02,6.606110652353426593e-03,4.376548307184145031e-02,7.142857142857142461e-02,1.005367464905037173e-01,6.729975227085054079e-02,3.468208092485548788e-02,7.638315441783650149e-03,4.046242774566474049e-02,3.158546655656482155e-02,1.321222130470685319e-02,1.151940545004128819e-01,4.025598678777869699e-02,0.000000000000000000e+00
|
66 |
+
4.293971924029727633e-02,1.341866226259289842e-02,3.922378199834847257e-03,3.385631709331131389e-02,6.090008257638315770e-02,1.527663088356730030e-02,4.748142031379025581e-03,6.193228736581337431e-04,1.238645747316267486e-03,5.140379851362510133e-02,5.966143682906688284e-01,2.890173410404624135e-03,3.055326176713460060e-02,8.051197357555739745e-03,1.857968620974401229e-03,5.780346820809248269e-03,5.573905862923203905e-03,3.943022295623451606e-02,1.383154417836498715e-02,5.326176713459950668e-02,0.000000000000000000e+00
|
67 |
+
4.438480594549958774e-02,9.909165978530139890e-03,3.509496284062758095e-03,2.642444260941370637e-02,8.670520231213871970e-03,1.362510322047894365e-02,2.105697770437654770e-02,6.606110652353426593e-03,2.890173410404624135e-03,8.670520231213871970e-03,3.059454995871180860e-01,1.032204789430223035e-02,1.527663088356730030e-02,4.013212221304706673e-01,2.064409578860445810e-03,1.465730800990916634e-02,1.094137076796036258e-02,8.257638315441783242e-03,2.374071015689512704e-02,1.837324525185796836e-02,0.000000000000000000e+00
|
68 |
+
8.154417836498761840e-02,3.715937241948802372e-02,1.682493806771263312e-01,1.300578034682080830e-01,3.922378199834847257e-03,6.193228736581337518e-02,1.944673823286540149e-01,1.816680429397192487e-02,1.837324525185796836e-02,2.270850536746490608e-02,5.243600330305532575e-02,4.232039636663913890e-02,2.539223781998348542e-02,4.748142031379025581e-03,1.445086705202312067e-03,3.344343517753922690e-02,2.559867877786952892e-02,6.812551610239471825e-03,1.321222130470685319e-02,2.312138728323699308e-02,0.000000000000000000e+00
|
69 |
+
4.975227085053674642e-02,5.367464905037159367e-02,1.888934764657307919e-01,6.069364161849710726e-02,3.096614368290668932e-03,1.232452518579686268e-01,7.390586292320396045e-02,1.692815854665565695e-02,3.488852188274153832e-02,2.146985962014863816e-02,5.450041288191577460e-02,1.102394715111478102e-01,8.876961189099917202e-03,1.176713459950454177e-02,1.300578034682080969e-02,4.748142031379025407e-02,2.353426919900908354e-02,6.399669694467382229e-03,1.919900908340214582e-02,1.300578034682080969e-02,0.000000000000000000e+00
|
70 |
+
1.527663088356730030e-02,1.672171758876961345e-02,7.844756399669694513e-03,7.448389760528488779e-01,4.541701073492981217e-03,1.032204789430223035e-02,2.270850536746490608e-02,4.541701073492981217e-03,1.630883567299752299e-02,3.034682080924855363e-02,2.559867877786952892e-02,1.507018992568125507e-02,5.780346820809248269e-03,7.018992568125516189e-03,6.193228736581337431e-04,2.683732452518579684e-02,8.876961189099917202e-03,1.445086705202312067e-03,8.257638315441783242e-03,7.225433526011560553e-03,0.000000000000000000e+00
|
71 |
+
2.353426919900908354e-02,1.630883567299752299e-02,2.890173410404624221e-02,1.486374896779520983e-02,1.114781172584640781e-02,9.289843104872005930e-03,2.332782824112304004e-02,3.303055326176713297e-03,6.812551610239471825e-03,1.998348472336911597e-01,1.587530966143682887e-01,2.415359207266721750e-02,1.734104046242774394e-02,5.429397192402972416e-02,8.257638315441783242e-04,1.899256812551610232e-02,9.909165978530139890e-03,3.096614368290668932e-03,3.406275805119735739e-02,2.215111478117258448e-01,0.000000000000000000e+00
|
72 |
+
8.257638315441784282e-02,3.261767134599504597e-02,5.677126341866226000e-02,2.514450867052023253e-01,3.303055326176713297e-03,7.762180016515277114e-02,9.682080924855490656e-02,1.238645747316267573e-02,9.083402146985962433e-03,1.011560693641618547e-01,4.892650701899256549e-02,6.234516928158546911e-02,1.197357555739058700e-02,6.193228736581337865e-03,2.064409578860445810e-03,2.848885218827415522e-02,2.931461601981833268e-02,2.270850536746490608e-03,7.018992568125516189e-03,1.383154417836498715e-02,0.000000000000000000e+00
|
73 |
+
1.816680429397192487e-01,7.865400495458299557e-02,3.654004954582989323e-02,3.096614368290668759e-02,1.218001651527663050e-02,3.819157720891824814e-02,8.402146985962015424e-02,1.383154417836498715e-02,1.940545004128819279e-02,1.069364161849711004e-01,3.426919900908340089e-02,8.484723369116432823e-02,1.259289843104871923e-02,6.399669694467382229e-03,1.857968620974401229e-03,4.810074318744839150e-02,8.381502890173410381e-02,4.748142031379025581e-03,1.073492981007431908e-02,4.335260115606936332e-02,0.000000000000000000e+00
|
74 |
+
3.874896779521057044e-01,4.810074318744839150e-02,2.085053674649050420e-02,1.857968620974401186e-02,2.642444260941370637e-02,1.837324525185796836e-02,4.459124690338563124e-02,8.876961189099917202e-03,2.601156069364161938e-02,7.886044591246903213e-02,3.860445912469033514e-02,3.075970272502064409e-02,1.176713459950454177e-02,2.064409578860446071e-02,1.651527663088356648e-03,3.468208092485548788e-02,7.700247729149463372e-02,3.509496284062758095e-03,1.052848885218827385e-02,6.977704376548307663e-02,0.000000000000000000e+00
|
75 |
+
3.323699421965317646e-02,2.559867877786952892e-02,1.775392237819983440e-02,1.589595375722543252e-02,2.436003303055326100e-02,3.137902559867877805e-02,8.773740710156895106e-02,5.367464905037159541e-03,1.445086705202312111e-02,1.463666391412056234e-01,8.918249380677126248e-02,4.376548307184145031e-02,1.259289843104871923e-02,1.156069364161849654e-02,4.128819157720891621e-04,2.043765483071841374e-02,4.995871180842278991e-02,3.715937241948802459e-03,1.878612716763005883e-02,2.838563170933113278e-01,0.000000000000000000e+00
|
76 |
+
9.186622625928984875e-02,1.525598678777869421e-01,4.459124690338563124e-02,7.184145334434351160e-02,1.775392237819983440e-02,4.025598678777869699e-02,1.166391412056151933e-01,1.259289843104871923e-02,1.754748142031379091e-02,4.335260115606936332e-02,4.252683732452518239e-02,7.947976878612716956e-02,1.321222130470685319e-02,1.341866226259289842e-02,1.651527663088356648e-03,9.021469859620148690e-02,4.417836498761354425e-02,3.715937241948802459e-03,7.638315441783650149e-03,1.218001651527663050e-02,0.000000000000000000e+00
|
77 |
+
8.732452518579686407e-02,1.238645747316267573e-02,2.910817506193228571e-02,1.649463253509496352e-01,1.878612716763005883e-02,4.500412881915771823e-02,1.591659785301403895e-01,1.304706853839801839e-01,1.238645747316267573e-02,1.486374896779520983e-02,4.727497935590421058e-02,3.984310487200660306e-02,1.032204789430223035e-02,1.238645747316267573e-02,3.096614368290668932e-03,4.149463253509496491e-02,4.624277456647398615e-02,6.193228736581337865e-03,1.032204789430223035e-02,1.878612716763005883e-02,0.000000000000000000e+00
|
78 |
+
1.350123864574731547e-01,1.011560693641618512e-02,1.796036333608587790e-02,5.099091659785301434e-02,1.443022295623451745e-01,3.241123038810900248e-02,9.186622625928984875e-02,4.335260115606935985e-03,7.225433526011560553e-03,1.364574731626754800e-01,1.387283236994219515e-01,2.126341866226259120e-02,1.238645747316267573e-02,1.300578034682080969e-02,4.335260115606935985e-03,2.436003303055326100e-02,1.857968620974401186e-02,4.954582989265069945e-03,1.341866226259289842e-02,4.789430222956234801e-02,0.000000000000000000e+00
|
79 |
+
5.553261767134599208e-02,5.491329479768786159e-02,3.158546655656482155e-02,6.461601981833195452e-02,2.167630057803468166e-02,3.860445912469033514e-02,8.443435177539224123e-02,1.341866226259289842e-02,1.899256812551610232e-02,1.176713459950454177e-02,2.807597027250206545e-01,1.005367464905037173e-01,1.094137076796036258e-02,1.011560693641618512e-02,2.064409578860445810e-03,4.830718414533443500e-02,2.580511973575557241e-02,3.509496284062758095e-03,1.424442609413707761e-02,2.477291494632535146e-02,0.000000000000000000e+00
|
80 |
+
7.762180016515277114e-02,2.177952105697770480e-01,1.692815854665565695e-02,6.151940545004128819e-02,8.051197357555739745e-03,3.901734104046242907e-02,5.966143682906688978e-02,2.043765483071841374e-02,2.188274153592072516e-02,2.704376548307184033e-02,2.146985962014863816e-02,9.454995871180842115e-02,8.051197357555739745e-03,1.011560693641618512e-02,4.748142031379025581e-03,6.007431874483897677e-02,5.119735755573905783e-02,3.509496284062758095e-03,7.638315441783650149e-03,3.736581337737407416e-02,0.000000000000000000e+00
|
81 |
+
1.734104046242774394e-02,9.496284062758051162e-03,8.876961189099917549e-02,2.023121387283237024e-02,3.509496284062758181e-02,1.527663088356730030e-02,1.651527663088356648e-02,3.715937241948802459e-03,6.606110652353426593e-03,8.051197357555739745e-03,2.539223781998348542e-02,9.289843104872005930e-03,5.986787778695293501e-03,1.548307184145334379e-02,2.064409578860445810e-03,1.919900908340214582e-02,1.672171758876961345e-02,3.509496284062758095e-03,8.670520231213871970e-03,1.465730800990916634e-02,0.000000000000000000e+00
|
82 |
+
9.145334434351774788e-02,7.844756399669694513e-03,3.096614368290668932e-03,7.431874483897604917e-03,8.876961189099917202e-03,5.161023947151115177e-03,1.630883567299752299e-02,1.114781172584640781e-02,5.573905862923203905e-03,8.464079273327828473e-03,8.670520231213871970e-03,2.497935590421139496e-02,3.096614368290668932e-03,1.465730800990916634e-02,1.011560693641618512e-02,1.672171758876961345e-02,6.812551610239471825e-03,3.509496284062758095e-03,4.541701073492981217e-03,8.670520231213871970e-03,0.000000000000000000e+00
|
83 |
+
1.796036333608587790e-02,1.424442609413707761e-02,1.135425268373245304e-02,8.257638315441783242e-03,1.445086705202312067e-03,6.399669694467382229e-03,1.341866226259289842e-02,1.445086705202312111e-02,9.702725020644096393e-03,1.630883567299752299e-02,1.321222130470685319e-02,9.971098265895954327e-02,3.096614368290668932e-03,1.156069364161849654e-02,3.096614368290668932e-03,1.527663088356730030e-02,1.507018992568125507e-02,4.748142031379025581e-03,8.257638315441783242e-03,1.919900908340214582e-02,0.000000000000000000e+00
|
84 |
+
7.617671345995045973e-02,3.158546655656482155e-02,3.406275805119735739e-02,1.135425268373245304e-02,4.954582989265069945e-03,1.548307184145334379e-02,3.075970272502064409e-02,1.857968620974401186e-02,2.642444260941370637e-02,4.252683732452518239e-02,3.187448389760528245e-01,7.638315441783650149e-03,7.844756399669694513e-03,2.828241123038810825e-02,6.193228736581337865e-03,2.477291494632535146e-02,2.291494632535094958e-02,7.844756399669694513e-03,1.878612716763005883e-02,3.179190751445086505e-02,0.000000000000000000e+00
|
85 |
+
2.642444260941370637e-02,1.279933938893476446e-02,1.713459950454170044e-02,1.919900908340214582e-02,8.464079273327828473e-03,1.156069364161849654e-02,3.179190751445086505e-02,3.715937241948802372e-02,3.488852188274153832e-02,5.966143682906688978e-02,1.251032204789430113e-01,6.709331131296449036e-02,1.403798513625103238e-02,1.294384805945499595e-01,1.589595375722543252e-02,2.064409578860446071e-02,1.424442609413707761e-02,2.436003303055326100e-02,1.151940545004128819e-01,5.243600330305532575e-02,0.000000000000000000e+00
|
86 |
+
3.633360858794384973e-02,1.486374896779520983e-02,2.704376548307184033e-02,5.924855491329479584e-02,6.812551610239471825e-03,1.672171758876961345e-02,4.975227085053674642e-02,4.892650701899256549e-02,8.670520231213871970e-03,1.445086705202312111e-02,1.672171758876961345e-02,2.146985962014863816e-02,4.748142031379025581e-03,1.837324525185796836e-02,3.934764657308009728e-01,7.803468208092485814e-02,2.229562345169281562e-02,2.353426919900908354e-02,1.445086705202312111e-02,5.986787778695293501e-03,0.000000000000000000e+00
|
87 |
+
3.199834847233690854e-02,8.464079273327828473e-03,6.874483897605285221e-02,6.606110652353426593e-02,3.426919900908340089e-02,1.754748142031379091e-02,3.839801816680429164e-02,4.438480594549958774e-02,1.259289843104871923e-02,2.807597027250206476e-02,4.376548307184145031e-02,1.486374896779520983e-02,6.193228736581337865e-03,6.771263418662262779e-02,7.225433526011560553e-03,3.075970272502064409e-02,2.043765483071841374e-02,2.710569777043765338e-01,1.238645747316267573e-02,1.083815028901734118e-01,0.000000000000000000e+00
|
88 |
+
3.199834847233690854e-02,1.259289843104871923e-02,2.105697770437654770e-02,8.670520231213871970e-03,7.638315441783650149e-03,6.399669694467382229e-03,2.456647398843930796e-02,1.568951279933938903e-02,1.052848885218827385e-02,2.828241123038810825e-02,2.972749793559041967e-02,1.135425268373245304e-02,9.289843104872005930e-03,2.871593724194880237e-01,9.909165978530139890e-03,1.692815854665565695e-02,2.807597027250206476e-02,1.696944673823286565e-01,1.829066886870354958e-01,3.901734104046242907e-02,0.000000000000000000e+00
|
89 |
+
6.151940545004128819e-02,9.537572254335259514e-02,7.060280759702725062e-02,3.007844756399669639e-01,7.225433526011560553e-03,2.869529314616019872e-02,7.080924855491330105e-02,4.211395540875309540e-02,1.630883567299752299e-02,1.568951279933938903e-02,3.137902559867877805e-02,4.624277456647398615e-02,9.083402146985962433e-03,1.465730800990916634e-02,2.436003303055326100e-02,4.665565648224608009e-02,3.592072667217175580e-02,8.670520231213871970e-03,1.403798513625103238e-02,2.332782824112304004e-02,0.000000000000000000e+00
|
90 |
+
5.057803468208092734e-02,4.087530966143682748e-02,8.319570602807596638e-02,1.007431874483897538e-01,1.362510322047894365e-02,5.635838150289017301e-02,8.216350123864574195e-02,7.287365813377373602e-02,1.672171758876961345e-02,9.496284062758051162e-03,2.332782824112304004e-02,7.947976878612716956e-02,1.383154417836498715e-02,3.323699421965317646e-02,1.032204789430223035e-02,1.670107349298100841e-01,6.007431874483897677e-02,1.527663088356730030e-02,1.321222130470685319e-02,1.383154417836498715e-02,0.000000000000000000e+00
|
91 |
+
1.445086705202312111e-02,6.606110652353426593e-03,2.167630057803468166e-02,1.218001651527663050e-02,1.878612716763005883e-02,1.341866226259289842e-02,1.362510322047894365e-02,5.986787778695293501e-03,1.073492981007431908e-02,2.477291494632535146e-02,6.284062758051197628e-01,9.702725020644096393e-03,2.745664739884393080e-02,4.913294797687861593e-02,5.718414533443435394e-02,8.464079273327828473e-03,8.876961189099917202e-03,1.610239471511147949e-02,1.754748142031379091e-02,1.218001651527663050e-02,0.000000000000000000e+00
|
92 |
+
8.257638315441783242e-03,3.922378199834847257e-03,9.475639966969447159e-02,4.265070189925680988e-01,2.085053674649050420e-02,1.259289843104871923e-02,3.984310487200660306e-02,1.445086705202312111e-02,7.018992568125516189e-03,4.128819157720891621e-03,3.922378199834847257e-03,1.011560693641618512e-02,2.890173410404624135e-03,3.922378199834847257e-03,2.076796036333608542e-01,8.319570602807596638e-02,2.766308835672997429e-02,1.238645747316267486e-03,3.509496284062758095e-03,3.715937241948802459e-03,0.000000000000000000e+00
|
93 |
+
1.364574731626754800e-01,1.734104046242774394e-02,2.931461601981833268e-02,1.156069364161849689e-01,1.527663088356730030e-02,3.943022295623451606e-02,2.890173410404624499e-01,4.066886870355078398e-02,9.702725020644096393e-03,1.424442609413707761e-02,2.621800165152766288e-02,3.364987613542527040e-02,5.367464905037159541e-03,8.670520231213871970e-03,1.048720066061106515e-01,5.078447563996697084e-02,2.002477291494632675e-02,3.922378199834847257e-03,6.606110652353426593e-03,1.156069364161849654e-02,0.000000000000000000e+00
|
94 |
+
8.753096614368290063e-02,1.094137076796036258e-02,6.317093311312964310e-02,4.624277456647398615e-02,7.844756399669694513e-03,2.621800165152766288e-02,1.215937241948802650e-01,1.424442609413707761e-02,4.748142031379025581e-03,3.426919900908340089e-02,2.291494632535094958e-02,2.952105697770437617e-02,6.399669694467382229e-03,2.270850536746490608e-03,8.753096614368290063e-02,2.663088356729975334e-02,3.158546655656482155e-02,1.445086705202312067e-03,2.064409578860445810e-03,3.175061932287365773e-01,0.000000000000000000e+00
|
95 |
+
7.452518579686209788e-02,5.105284888521882669e-01,1.651527663088356648e-03,4.541701073492981217e-03,5.573905862923203905e-03,3.488852188274153832e-02,3.550784475639966881e-02,1.135425268373245304e-02,4.335260115606935985e-03,5.924855491329479584e-02,1.362510322047894365e-02,1.672171758876961345e-02,4.748142031379025581e-03,2.890173410404624135e-03,2.539223781998348542e-02,5.367464905037159541e-03,4.954582989265069945e-03,9.702725020644096393e-03,2.270850536746490608e-03,1.009496284062758042e-01,0.000000000000000000e+00
|
96 |
+
2.456647398843930796e-02,1.379025598678777775e-01,6.606110652353426593e-03,4.541701073492981217e-03,4.128819157720891621e-03,4.995871180842278991e-01,6.131296449215524469e-02,4.128819157720891621e-03,8.876961189099917202e-03,1.981833195706027978e-02,1.383154417836498715e-02,1.284062758051197350e-01,5.573905862923203905e-03,1.981833195706027978e-02,2.270850536746490608e-03,8.464079273327828473e-03,7.018992568125516189e-03,1.238645747316267486e-03,9.702725020644096393e-03,1.568951279933938903e-02,0.000000000000000000e+00
|
97 |
+
1.108587943848059476e-01,1.061106523534269264e-01,3.839801816680429164e-02,8.443435177539224123e-02,3.963666391412055956e-02,6.028075970272502027e-02,1.100330305532617736e-01,7.060280759702725062e-02,4.933938893476465942e-02,3.922378199834847257e-02,8.484723369116432823e-02,2.353426919900908354e-02,4.004954582989265349e-02,7.638315441783650149e-03,1.651527663088356648e-03,2.539223781998348542e-02,2.167630057803468166e-02,3.509496284062758095e-03,8.670520231213871970e-03,3.839801816680429164e-02,0.000000000000000000e+00
|
98 |
+
2.632122213047068393e-01,2.477291494632534972e-03,2.064409578860445810e-04,3.509496284062758095e-03,8.051197357555739745e-03,2.023121387283237024e-02,2.477291494632534972e-03,1.073492981007431908e-02,1.445086705202312067e-03,1.583402146985961878e-01,1.218001651527663050e-02,7.844756399669694513e-03,4.541701073492981217e-03,9.909165978530139890e-03,6.193228736581337431e-04,3.096614368290668932e-03,3.715937241948802459e-03,0.000000000000000000e+00,2.477291494632534972e-03,4.700660611065235472e-01,0.000000000000000000e+00
|
99 |
+
3.715937241948802459e-03,8.257638315441783242e-04,4.128819157720891621e-04,2.064409578860445810e-04,2.394715111478117400e-02,3.509496284062758095e-03,1.857968620974401229e-03,1.238645747316267486e-03,2.477291494632534972e-03,1.385218827415359288e-01,6.061106523534268709e-01,6.193228736581337431e-04,5.450041288191577460e-02,1.589595375722543252e-02,4.128819157720891621e-04,2.064409578860445810e-03,5.986787778695293501e-03,2.064409578860445810e-04,1.857968620974401229e-03,1.096201486374896727e-01,0.000000000000000000e+00
|
100 |
+
1.407927332782824004e-01,2.064409578860445810e-03,1.445086705202312067e-03,2.270850536746490608e-03,2.374071015689512704e-02,1.424442609413707761e-02,1.568951279933938903e-02,8.464079273327828473e-03,1.651527663088356648e-03,3.084227910817506357e-01,7.762180016515277114e-02,2.064409578860445810e-03,3.096614368290668759e-02,2.270850536746490608e-03,6.193228736581337431e-04,4.335260115606935985e-03,5.202312138728323876e-02,2.064409578860445810e-03,1.403798513625103238e-02,2.630057803468208166e-01,0.000000000000000000e+00
|
101 |
+
9.496284062758051162e-03,1.032204789430222905e-03,4.942196531791907543e-01,2.625928984310487158e-01,4.335260115606935985e-03,8.051197357555739745e-03,1.092072667217175858e-01,3.922378199834847257e-03,5.986787778695293501e-03,8.876961189099917202e-03,2.683732452518579770e-03,2.064409578860445810e-04,6.193228736581337865e-03,4.128819157720891621e-04,0.000000000000000000e+00,7.328654004954582302e-02,1.445086705202312067e-03,0.000000000000000000e+00,8.257638315441783242e-04,3.096614368290668932e-03,0.000000000000000000e+00
|
102 |
+
2.890173410404624135e-03,4.128819157720891621e-04,2.064409578860445810e-04,4.128819157720891621e-04,4.128819157720891621e-03,1.857968620974401229e-03,4.128819157720891621e-04,4.128819157720891621e-04,0.000000000000000000e+00,1.878612716763005883e-02,9.744013212221304399e-02,4.128819157720891621e-04,8.499174236168456353e-01,8.257638315441783242e-03,2.064409578860445810e-04,8.257638315441783242e-04,2.064409578860445810e-04,8.257638315441783242e-04,4.128819157720891621e-04,9.083402146985962433e-03,0.000000000000000000e+00
|
103 |
+
2.978943022295623688e-01,1.857968620974401186e-02,6.606110652353426593e-03,9.496284062758051162e-03,1.682493806771263312e-01,1.032204789430222905e-03,1.445086705202312067e-03,2.250206440957885912e-02,5.986787778695293501e-03,4.582989265070189916e-02,2.085053674649050420e-02,2.064409578860445810e-04,1.624690338563170855e-01,2.683732452518579770e-03,1.445086705202312067e-03,5.429397192402972416e-02,5.367464905037159367e-02,0.000000000000000000e+00,5.780346820809248269e-03,1.184971098265895917e-01,0.000000000000000000e+00
|
104 |
+
0.000000000000000000e+00,6.193228736581337431e-04,1.238645747316267486e-03,2.477291494632534972e-03,1.857968620974401229e-03,0.000000000000000000e+00,4.128819157720891621e-04,2.064409578860445810e-04,3.922378199834847257e-03,1.857968620974401229e-03,4.335260115606935985e-03,2.064409578860445810e-04,1.857968620974401229e-03,8.247316267547480928e-01,0.000000000000000000e+00,1.857968620974401229e-03,6.193228736581337431e-04,8.257638315441783242e-04,1.509083402146985942e-01,8.257638315441783242e-04,0.000000000000000000e+00
|
105 |
+
2.064409578860445810e-03,0.000000000000000000e+00,6.820809248554913218e-01,2.270850536746490608e-03,1.032204789430222905e-03,2.731213872832369827e-01,3.303055326176713297e-03,1.445086705202312067e-03,1.445086705202312067e-03,2.064409578860445810e-04,1.857968620974401229e-03,1.032204789430222905e-03,5.367464905037159541e-03,8.257638315441783242e-04,4.128819157720891621e-04,4.335260115606935985e-03,3.096614368290668932e-03,6.193228736581337431e-04,8.257638315441783242e-04,1.857968620974401229e-03,0.000000000000000000e+00
|
106 |
+
2.683732452518579770e-03,3.096614368290668932e-03,8.257638315441783242e-04,1.445086705202312067e-03,1.857968620974401229e-03,4.128819157720891621e-04,1.238645747316267486e-03,6.193228736581337431e-04,6.193228736581337431e-04,2.745664739884393080e-02,5.660611065235342521e-01,6.193228736581337431e-04,3.647811725846407671e-01,1.857968620974401229e-03,6.193228736581337431e-04,1.032204789430222905e-03,2.064409578860445810e-03,0.000000000000000000e+00,0.000000000000000000e+00,1.321222130470685319e-02,0.000000000000000000e+00
|
107 |
+
1.032204789430222905e-03,1.651527663088356648e-03,6.193228736581337431e-04,6.193228736581337431e-04,0.000000000000000000e+00,3.303055326176713297e-03,2.064409578860445810e-04,9.754335260115607475e-01,0.000000000000000000e+00,0.000000000000000000e+00,4.128819157720891621e-04,1.238645747316267486e-03,2.064409578860445810e-04,2.890173410404624135e-03,0.000000000000000000e+00,1.857968620974401229e-03,0.000000000000000000e+00,2.064409578860445810e-04,1.857968620974401229e-03,2.064409578860445810e-04,0.000000000000000000e+00
|
108 |
+
5.780346820809248443e-02,1.521469859620148690e-01,1.692815854665565695e-02,1.114781172584640781e-02,4.128819157720891621e-03,1.796036333608587790e-02,2.952105697770437617e-02,3.468208092485548788e-02,4.748142031379025581e-03,1.399669694467382264e-01,1.327415359207266832e-01,3.137902559867877805e-02,1.857968620974401186e-02,2.312138728323699308e-02,3.426919900908340089e-02,1.857968620974401186e-02,2.745664739884393080e-02,1.156069364161849654e-02,5.346820809248555018e-02,1.445086705202312249e-01,0.000000000000000000e+00
|
109 |
+
8.649876135425269008e-02,2.601156069364161938e-02,6.213872832369941868e-02,3.922378199834847257e-02,1.238645747316267486e-03,1.692815854665565695e-02,2.332782824112304004e-02,1.133360858794384834e-01,2.353426919900908354e-02,4.128819157720891621e-03,1.651527663088356648e-02,4.293971924029727633e-02,2.064409578860445810e-03,5.161023947151115177e-03,2.429810074318744795e-01,7.597027250206440929e-02,1.707266721717588809e-01,1.238645747316267486e-03,1.032204789430223035e-02,1.094137076796036258e-02,0.000000000000000000e+00
|
110 |
+
8.670520231213871970e-03,3.893476465730800751e-01,1.651527663088356648e-02,4.748142031379025581e-03,4.128819157720891621e-04,3.096614368290668932e-03,2.270850536746490608e-03,4.097853014037985409e-01,6.606110652353426593e-03,6.193228736581337431e-04,2.890173410404624135e-03,7.947976878612716956e-02,6.193228736581337431e-04,1.238645747316267486e-03,1.857968620974401229e-03,1.507018992568125507e-02,2.993393889347646664e-02,1.465730800990916634e-02,4.128819157720891621e-04,1.445086705202312067e-03,0.000000000000000000e+00
|
111 |
+
1.114781172584640781e-02,5.161023947151115177e-03,8.257638315441783242e-04,6.193228736581337431e-04,5.367464905037159541e-03,5.367464905037159541e-03,2.477291494632534972e-03,1.445086705202312067e-03,2.270850536746490608e-03,1.052848885218827385e-02,6.323286540049546378e-01,1.651527663088356648e-03,1.486374896779520983e-02,1.234516928158546634e-01,6.399669694467382229e-03,2.477291494632534972e-03,1.445086705202312111e-02,1.424442609413707761e-02,1.816680429397192487e-02,1.207679603633360910e-01,0.000000000000000000e+00
|
112 |
+
1.114781172584640850e-01,6.296449215524360654e-02,2.663088356729975334e-02,9.496284062758051162e-03,2.910817506193228571e-02,1.754748142031379091e-02,1.197357555739058700e-02,4.190751445086705190e-02,3.715937241948802459e-03,3.303055326176713297e-03,2.372006606110652338e-01,6.110652353426920119e-02,5.511973575557390509e-02,8.876961189099917202e-03,3.715937241948802459e-03,2.869529314616020010e-01,1.383154417836498715e-02,1.445086705202312067e-03,1.445086705202312067e-03,5.780346820809248269e-03,0.000000000000000000e+00
|
113 |
+
3.881090008257638557e-02,4.232039636663913890e-02,3.323699421965317646e-02,1.052848885218827385e-02,1.857968620974401229e-03,6.131296449215524469e-02,3.757225433526011765e-02,2.233691164327002432e-01,1.156069364161849654e-02,8.257638315441783242e-04,1.589595375722543252e-02,4.135012386457473377e-01,5.161023947151115177e-03,1.238645747316267486e-03,2.064409578860445810e-03,4.686209744013212358e-02,4.727497935590421058e-02,6.193228736581337431e-04,2.270850536746490608e-03,2.064409578860445810e-04,0.000000000000000000e+00
|
114 |
+
1.032204789430222905e-03,2.890173410404624135e-03,1.032204789430222905e-03,6.193228736581337431e-04,8.257638315441783242e-04,6.193228736581337431e-04,1.238645747316267486e-03,1.445086705202312067e-03,2.064409578860445810e-04,8.257638315441783242e-04,6.399669694467382229e-03,3.303055326176713297e-03,8.257638315441783242e-04,9.525185796862097876e-01,6.193228736581337431e-04,2.890173410404624135e-03,1.032204789430222905e-03,1.507018992568125507e-02,1.651527663088356648e-03,2.064409578860445810e-03,0.000000000000000000e+00
|
115 |
+
1.321222130470685319e-02,1.224194880264244389e-01,1.465730800990916634e-02,3.509496284062758095e-03,1.032204789430222905e-03,2.353426919900908354e-02,1.940545004128819279e-02,7.844756399669694513e-03,6.007431874483897677e-02,9.496284062758051162e-03,7.225433526011560553e-03,4.618084227910817519e-01,2.890173410404624135e-03,4.128819157720891621e-03,3.282411230388108947e-02,1.507018992568125507e-02,7.369942196531792389e-02,1.651527663088356648e-03,2.890173410404624135e-03,8.113129644921551753e-02,0.000000000000000000e+00
|
116 |
+
1.300578034682080969e-02,8.402146985962015424e-02,2.803468208092485536e-01,2.208918249380677212e-02,1.238645747316267486e-03,2.766308835672997429e-02,1.135425268373245304e-02,6.420313790255986752e-02,3.406275805119735739e-02,1.011560693641618512e-02,1.568951279933938903e-02,3.563170933113129490e-01,8.876961189099917202e-03,2.890173410404624135e-03,2.477291494632534972e-03,1.259289843104871923e-02,2.270850536746490608e-02,2.477291494632534972e-03,1.445086705202312067e-03,8.464079273327828473e-03,0.000000000000000000e+00
|
117 |
+
5.677126341866226000e-02,4.954582989265069945e-03,1.032204789430222905e-03,3.509496284062758095e-03,3.096614368290668932e-03,3.509496284062758095e-03,1.857968620974401229e-03,5.367464905037159541e-03,1.630883567299752299e-02,3.715937241948802459e-03,3.530140379851362531e-02,2.374071015689512704e-02,4.099917423616845635e-01,1.767134599504541770e-01,2.683732452518579770e-03,3.509496284062758181e-02,1.890999174236168423e-01,2.890173410404624135e-03,2.064409578860445810e-03,3.922378199834847257e-03,0.000000000000000000e+00
|
118 |
+
8.876961189099917202e-03,3.654004954582989323e-02,5.161023947151114483e-02,1.032204789430222905e-03,2.477291494632534972e-03,8.051197357555739745e-03,1.238645747316267486e-03,3.096614368290668932e-03,1.734104046242774394e-02,1.744426094137076777e-01,4.403385631709331172e-01,1.102394715111478102e-01,1.672171758876961345e-02,2.085053674649050420e-02,2.683732452518579770e-03,4.748142031379025581e-03,1.073492981007431908e-02,6.544178364987612850e-02,3.509496284062758095e-03,1.135425268373245304e-02,0.000000000000000000e+00
|
119 |
+
3.701486374896779674e-01,9.537572254335259514e-02,2.890173410404624221e-02,2.890173410404624221e-02,1.651527663088356648e-03,3.282411230388108947e-02,4.479768786127167474e-02,4.624277456647398615e-02,1.445086705202312111e-02,1.465730800990916634e-02,2.043765483071841374e-02,1.248967795210569748e-01,9.496284062758051162e-03,9.083402146985962433e-03,2.890173410404624135e-03,5.532617671345994859e-02,3.839801816680429164e-02,3.922378199834847257e-03,9.496284062758051162e-03,9.289843104872005930e-03,0.000000000000000000e+00
|
120 |
+
5.712221304706853742e-01,5.367464905037159541e-03,1.919900908340214582e-02,1.507018992568125507e-02,2.126341866226259120e-02,6.606110652353426593e-03,9.702725020644096393e-03,4.995871180842278991e-02,3.922378199834847257e-02,1.011560693641618512e-02,4.128819157720892141e-02,1.527663088356730030e-02,7.473162675474814831e-02,2.332782824112304004e-02,1.857968620974401229e-03,2.188274153592072516e-02,5.986787778695293501e-03,2.064409578860445810e-03,4.252683732452518239e-02,5.986787778695293501e-03,0.000000000000000000e+00
|
121 |
+
5.842279108175062186e-02,3.096614368290668932e-03,5.573905862923203905e-03,5.780346820809248269e-03,2.559867877786952892e-02,1.445086705202312067e-03,9.702725020644096393e-03,4.128819157720891621e-03,3.096614368290668932e-03,2.266721717588769669e-01,3.342279108175061908e-01,7.225433526011560553e-03,8.051197357555739398e-02,1.052848885218827385e-02,8.257638315441783242e-04,6.399669694467382229e-03,7.431874483897604917e-03,1.445086705202312067e-03,3.922378199834847257e-03,1.932287365813377400e-01,0.000000000000000000e+00
|
122 |
+
1.083815028901734118e-01,7.576383154417835886e-02,6.833195706028076521e-02,8.711808422791081363e-02,5.780346820809248269e-03,1.255161023947151122e-01,1.860033030553261690e-01,1.713459950454170044e-02,3.303055326176713297e-02,2.890173410404624221e-02,2.456647398843930796e-02,9.847233691164326841e-02,1.114781172584640781e-02,6.399669694467382229e-03,1.032204789430222905e-03,4.603633360858794266e-02,1.135425268373245304e-02,2.477291494632534972e-03,9.496284062758051162e-03,2.374071015689512704e-02,0.000000000000000000e+00
|
123 |
+
2.101568951279934039e-01,7.266721717588769947e-02,8.195706028075970540e-02,8.505367464905036479e-02,7.844756399669694513e-03,7.328654004954582302e-02,1.391412056151940524e-01,2.497935590421139496e-02,1.424442609413707761e-02,3.261767134599504597e-02,2.394715111478117400e-02,5.140379851362510133e-02,1.775392237819983440e-02,4.335260115606935985e-03,2.683732452518579770e-03,6.668042939719240336e-02,2.931461601981833268e-02,2.064409578860445810e-04,3.715937241948802459e-03,4.149463253509496491e-02,0.000000000000000000e+00
|
124 |
+
3.777869529314616115e-02,8.298926507018992982e-02,4.459124690338563124e-02,1.919900908340214582e-02,6.606110652353426593e-03,4.644921552436002965e-02,8.113129644921551753e-02,3.420726672171758853e-01,5.264244426094136925e-02,4.335260115606935985e-03,1.568951279933938903e-02,1.843517753922378211e-01,4.954582989265069945e-03,3.096614368290668932e-03,3.922378199834847257e-03,3.943022295623451606e-02,3.096614368290668932e-03,2.064409578860445810e-04,6.193228736581337865e-03,5.780346820809248269e-03,0.000000000000000000e+00
|
125 |
+
2.890173410404624221e-02,1.149876135425268314e-01,1.676300578034682076e-01,4.667630057803467958e-01,3.096614368290668932e-03,4.190751445086705190e-02,4.335260115606936332e-02,1.383154417836498715e-02,1.052848885218827385e-02,2.064409578860445810e-03,9.289843104872005930e-03,2.931461601981833268e-02,5.367464905037159541e-03,5.161023947151115177e-03,2.064409578860445810e-03,1.878612716763005883e-02,2.477291494632534972e-03,1.445086705202312067e-03,1.052848885218827385e-02,2.890173410404624135e-03,0.000000000000000000e+00
|
126 |
+
1.341866226259289842e-02,9.496284062758051162e-03,1.383154417836498715e-02,1.713459950454170044e-02,3.509496284062758095e-03,4.335260115606935985e-03,9.702725020644096393e-03,3.282411230388108947e-02,8.670520231213871970e-03,6.193228736581337865e-03,7.225433526011560553e-03,1.300578034682080969e-02,5.161023947151115177e-03,1.265483071841453366e-01,5.367464905037159541e-03,4.541701073492981217e-03,4.335260115606935985e-03,4.312551610239471755e-01,2.755986787778695324e-01,2.890173410404624135e-03,0.000000000000000000e+00
|
127 |
+
1.007431874483897538e-01,1.754748142031379091e-02,7.493806771263418487e-02,1.874483897605284943e-01,2.270850536746490608e-03,5.677126341866226000e-02,1.207679603633360910e-01,2.477291494632535146e-02,2.353426919900908354e-02,1.981833195706027978e-02,2.580511973575557241e-02,1.158133773740710193e-01,5.573905862923203905e-03,1.940545004128819279e-02,2.848885218827415522e-02,6.069364161849710726e-02,3.901734104046242907e-02,2.477291494632534972e-03,2.828241123038810825e-02,3.571428571428571230e-02,0.000000000000000000e+00
|
128 |
+
1.061106523534269264e-01,6.461601981833195452e-02,2.126341866226259120e-02,3.426919900908340089e-02,4.748142031379025581e-03,6.007431874483897677e-02,2.493806771263418764e-01,6.668042939719240336e-02,3.922378199834847257e-03,1.383154417836498715e-02,6.709331131296449036e-02,9.723369116432700743e-02,1.568951279933938903e-02,5.367464905037159541e-03,3.303055326176713297e-03,3.323699421965317646e-02,1.108587943848059476e-01,2.890173410404624135e-03,7.225433526011560553e-03,2.621800165152766288e-02,0.000000000000000000e+00
|
129 |
+
8.744838976052848878e-01,2.270850536746490608e-03,1.238645747316267486e-03,8.257638315441783242e-04,8.257638315441783242e-03,2.064409578860445810e-03,3.922378199834847257e-03,5.161023947151115177e-03,4.128819157720891621e-04,2.270850536746490608e-03,3.715937241948802459e-03,4.954582989265069945e-03,3.922378199834847257e-02,8.257638315441783242e-04,8.257638315441783242e-04,1.011560693641618512e-02,7.431874483897604917e-03,4.128819157720891621e-04,4.128819157720891621e-04,2.353426919900908354e-02,0.000000000000000000e+00
|
130 |
+
7.431874483897604744e-01,7.431874483897604917e-03,1.445086705202312067e-03,3.096614368290668932e-03,1.156069364161849654e-02,3.922378199834847257e-03,9.909165978530139890e-03,3.530140379851362531e-02,1.032204789430223035e-02,1.073492981007431908e-02,1.238645747316267486e-03,1.197357555739058700e-02,4.128819157720891621e-03,1.857968620974401229e-03,1.445086705202312067e-03,1.209744013212221275e-01,3.303055326176713297e-03,2.064409578860445810e-04,1.032204789430223035e-02,5.986787778695293501e-03,0.000000000000000000e+00
|
131 |
+
1.244838976052848878e-01,4.644921552436002965e-02,5.305532617671346318e-02,1.721717588769611784e-01,3.509496284062758095e-03,3.220478943022295898e-02,9.744013212221304399e-02,3.117258464079273456e-02,1.383154417836498715e-02,5.367464905037159367e-02,4.232039636663913890e-02,8.938893476465731291e-02,1.011560693641618512e-02,1.837324525185796836e-02,2.064409578860445810e-03,4.541701073492981217e-02,3.426919900908340089e-02,2.270850536746490608e-03,1.548307184145334379e-02,1.042526837324525141e-01,0.000000000000000000e+00
|
132 |
+
5.388109000825763717e-02,8.051197357555739745e-03,6.151940545004128819e-02,4.108175061932287098e-02,2.890173410404624135e-03,1.104459124690338606e-01,5.586292320396366584e-01,5.388109000825763717e-02,1.961189099917423628e-02,6.812551610239471825e-03,2.890173410404624135e-03,5.367464905037159541e-03,4.562345169281585566e-02,1.857968620974401229e-03,8.257638315441783242e-04,1.568951279933938903e-02,1.238645747316267486e-03,2.064409578860445810e-04,1.445086705202312067e-03,2.477291494632534972e-03,0.000000000000000000e+00
|
133 |
+
4.624277456647398615e-02,5.367464905037159541e-03,2.064409578860445810e-04,2.270850536746490608e-03,5.780346820809248269e-03,1.073492981007431908e-02,1.940545004128819279e-02,9.104046242774566089e-02,1.445086705202312067e-03,2.807597027250206476e-02,1.944673823286540149e-01,3.096614368290668932e-03,5.472749793559041898e-01,2.188274153592072516e-02,2.064409578860445810e-04,4.335260115606935985e-03,1.032204789430222905e-03,4.128819157720891621e-04,4.128819157720891621e-04,1.094137076796036258e-02,0.000000000000000000e+00
|
134 |
+
8.505367464905036479e-02,1.277869529314616115e-01,2.683732452518579770e-03,6.399669694467382229e-03,1.857968620974401229e-03,2.910817506193228571e-02,7.493806771263418487e-02,6.606110652353426593e-03,5.780346820809248269e-03,3.055326176713460060e-02,3.501238645747316025e-01,7.266721717588769947e-02,8.526011560693641522e-02,4.748142031379025581e-03,1.032204789430222905e-03,9.496284062758051162e-03,9.496284062758051162e-03,1.445086705202312067e-03,4.128819157720891621e-03,6.874483897605285221e-02,0.000000000000000000e+00
|
135 |
+
2.910817506193228571e-02,1.857968620974401186e-02,1.521469859620148690e-01,5.464492155243599880e-01,1.032204789430222905e-03,3.344343517753922690e-02,1.754748142031379091e-02,2.085053674649050420e-02,1.032204789430223035e-02,1.238645747316267486e-03,8.051197357555739745e-03,6.048720066061106376e-02,2.477291494632534972e-03,1.238645747316267486e-03,1.651527663088356648e-03,3.571428571428571230e-02,1.176713459950454177e-02,1.032204789430222905e-03,6.193228736581337431e-04,5.573905862923203905e-03,0.000000000000000000e+00
|
136 |
+
2.477291494632534972e-03,1.857968620974401229e-03,4.128819157720891621e-04,1.445086705202312067e-03,1.445086705202312067e-03,1.238645747316267486e-03,1.857968620974401229e-03,3.509496284062758095e-03,4.128819157720891621e-04,1.032204789430222905e-03,1.032204789430222905e-03,5.161023947151115177e-03,1.032204789430222905e-03,8.257638315441783242e-04,1.857968620974401229e-03,9.287778695293146258e-01,3.199834847233690854e-02,6.193228736581337431e-04,4.128819157720891621e-04,6.193228736581337431e-04,0.000000000000000000e+00
|
137 |
+
6.771263418662262779e-02,3.005780346820809412e-01,2.436003303055326100e-02,1.568951279933938903e-02,6.193228736581337431e-04,1.961189099917423628e-02,1.692815854665565695e-02,3.715937241948802459e-03,8.051197357555739745e-03,6.606110652353426593e-03,1.837324525185796975e-01,2.712634186622626120e-01,2.683732452518579770e-03,8.257638315441783242e-04,1.032204789430223035e-02,9.909165978530139890e-03,2.023121387283237024e-02,1.857968620974401229e-03,5.573905862923203905e-03,1.816680429397192487e-02,0.000000000000000000e+00
|
138 |
+
1.651527663088356648e-02,2.064409578860445810e-03,1.032204789430222905e-03,1.032204789430222905e-03,4.128819157720891621e-04,1.032204789430222905e-03,6.193228736581337431e-04,3.303055326176713297e-03,8.257638315441783242e-04,4.128819157720891621e-04,5.780346820809248269e-03,1.445086705202312067e-03,1.032204789430222905e-03,4.748142031379025581e-03,1.032204789430222905e-03,8.257638315441783242e-04,1.032204789430222905e-03,8.980181668042940268e-01,4.046242774566474049e-02,3.509496284062758095e-03,0.000000000000000000e+00
|
139 |
+
4.618084227910817519e-01,2.931461601981833268e-02,7.431874483897604917e-03,3.303055326176713297e-03,2.601156069364161938e-02,8.257638315441783242e-04,3.715937241948802459e-03,4.954582989265069945e-03,6.234516928158546911e-02,2.270850536746490608e-03,1.238645747316267486e-03,1.032204789430223035e-02,6.193228736581337431e-04,5.677126341866226000e-02,3.303055326176713297e-03,2.208918249380677212e-02,3.922378199834847257e-03,4.541701073492981217e-03,2.819983484723369016e-01,3.922378199834847257e-03,0.000000000000000000e+00
|
140 |
+
1.878612716763005883e-02,2.268786127167630173e-01,6.379025598678778053e-02,3.117258464079273456e-02,1.857968620974401229e-03,4.314616019818331982e-02,4.644921552436002965e-02,6.337737407101569354e-02,2.126341866226259120e-02,1.238645747316267573e-02,8.257638315441783242e-03,2.652766308835672882e-01,4.335260115606935985e-03,2.477291494632534972e-03,2.477291494632534972e-03,5.780346820809248443e-02,8.773740710156895106e-02,1.238645747316267486e-03,4.748142031379025581e-03,2.374071015689512704e-02,0.000000000000000000e+00
|
141 |
+
1.651527663088356648e-03,4.128819157720891621e-03,8.257638315441783242e-04,2.436003303055326100e-02,4.128819157720891621e-04,9.031791907514450379e-01,2.910817506193228571e-02,3.303055326176713297e-03,1.238645747316267486e-03,6.193228736581337431e-04,2.477291494632534972e-03,4.128819157720891621e-03,8.257638315441783242e-04,4.128819157720891621e-04,1.238645747316267486e-03,1.032204789430222905e-03,1.445086705202312067e-03,2.064409578860445810e-04,6.193228736581337431e-04,7.431874483897604917e-03,0.000000000000000000e+00
|
142 |
+
1.445086705202312111e-02,1.651527663088356648e-03,2.270850536746490608e-03,2.270850536746490608e-03,2.477291494632534972e-03,4.335260115606935985e-03,2.477291494632534972e-03,1.589595375722543252e-02,3.303055326176713297e-03,3.096614368290668932e-03,1.796036333608587790e-02,3.715937241948802459e-03,4.128819157720891621e-04,1.651527663088356648e-03,1.032204789430222905e-03,1.176713459950454177e-02,2.706440957886044330e-01,0.000000000000000000e+00,6.193228736581337431e-04,6.263418662262593140e-01,0.000000000000000000e+00
|
143 |
+
6.193228736581337865e-03,1.011560693641618512e-02,3.096614368290668932e-03,3.096614368290668932e-03,1.032204789430222905e-03,5.780346820809248269e-03,5.161023947151115177e-03,3.973988439306358478e-01,7.431874483897604917e-03,2.064409578860445810e-03,1.651527663088356648e-03,9.434351775392238459e-02,6.193228736581337431e-04,2.064409578860445810e-03,3.096614368290668828e-01,7.225433526011560553e-03,1.193228736581337796e-01,2.064409578860445810e-04,5.161023947151115177e-03,3.096614368290668932e-03,0.000000000000000000e+00
|
144 |
+
1.063170933113129629e-01,8.484723369116432823e-02,2.923203963666391458e-01,5.181668042939719526e-02,6.193228736581337431e-04,4.624277456647398615e-02,5.078447563996697084e-02,7.390586292320396045e-02,1.651527663088356648e-02,7.844756399669694513e-03,1.321222130470685319e-02,7.947976878612716956e-02,4.541701073492981217e-03,1.651527663088356648e-03,2.518579686209743845e-02,6.688687035507845380e-02,3.323699421965317646e-02,0.000000000000000000e+00,5.573905862923203905e-03,2.105697770437654770e-02,0.000000000000000000e+00
|
145 |
+
2.064409578860445810e-04,9.640792733278282789e-01,2.064409578860445810e-04,6.193228736581337431e-04,0.000000000000000000e+00,1.032204789430222905e-03,1.238645747316267486e-03,2.270850536746490608e-03,1.032204789430222905e-03,8.257638315441783242e-04,1.651527663088356648e-03,2.890173410404624135e-03,0.000000000000000000e+00,0.000000000000000000e+00,8.257638315441783242e-04,8.257638315441783242e-04,8.257638315441783242e-04,0.000000000000000000e+00,8.257638315441783242e-04,1.651527663088356648e-03,0.000000000000000000e+00
|
146 |
+
7.186209744013212219e-01,5.780346820809248269e-03,6.193228736581337431e-04,6.193228736581337431e-04,4.314616019818331982e-02,1.651527663088356648e-03,1.857968620974401229e-03,3.819157720891824814e-02,6.193228736581337431e-04,2.064409578860445810e-03,4.128819157720891621e-03,1.445086705202312067e-03,8.257638315441783242e-04,1.032204789430222905e-03,3.096614368290668932e-03,8.629232039636663965e-02,5.573905862923203905e-03,2.064409578860445810e-03,1.362510322047894365e-02,4.273327828241123283e-02,0.000000000000000000e+00
|
147 |
+
2.848885218827415522e-02,5.800990916597852792e-02,5.945499587118083934e-02,6.977704376548307663e-02,8.257638315441783242e-04,7.101568951279933761e-02,1.899256812551610163e-01,2.167630057803468166e-02,2.291494632535094958e-02,4.190751445086705190e-02,3.757225433526011765e-02,1.571015689512799407e-01,8.670520231213871970e-03,1.032204789430222905e-03,1.940545004128819279e-02,3.261767134599504597e-02,6.895127993393888877e-02,1.238645747316267486e-03,5.986787778695293501e-03,7.184145334434351160e-02,0.000000000000000000e+00
|
148 |
+
1.857968620974401186e-02,5.666804293971924311e-01,2.250206440957885912e-02,4.046242774566474049e-02,1.238645747316267486e-03,1.589595375722543252e-02,1.546242774566473910e-01,8.464079273327828473e-03,8.257638315441783242e-03,8.464079273327828473e-03,7.225433526011560553e-03,4.748142031379025407e-02,2.270850536746490608e-03,6.193228736581337865e-03,4.128819157720891621e-03,1.321222130470685319e-02,2.848885218827415522e-02,8.257638315441783242e-04,1.094137076796036258e-02,5.161023947151115177e-03,0.000000000000000000e+00
|
149 |
+
7.018992568125516189e-03,3.096614368290668932e-03,3.158546655656482155e-02,4.541701073492981217e-02,4.128819157720891621e-04,6.399669694467382229e-03,8.670520231213871970e-03,2.270850536746490608e-03,3.777869529314616115e-02,5.429397192402972416e-02,6.352188274153591774e-01,1.651527663088356648e-03,3.715937241948802372e-02,2.683732452518579770e-03,1.032204789430222905e-03,2.064409578860445810e-03,6.606110652353426593e-03,4.128819157720891621e-04,3.715937241948802459e-03,7.597027250206440929e-02,0.000000000000000000e+00
|
150 |
+
3.226672171758876995e-01,2.580511973575557241e-02,3.715937241948802459e-03,1.032204789430222905e-03,3.447563996696944438e-02,2.497935590421139496e-02,1.568951279933938903e-02,5.161023947151115177e-03,2.064409578860445810e-03,1.195293146160198161e-01,1.135425268373245304e-02,8.670520231213871970e-03,8.918249380677126248e-02,6.193228736581337431e-04,1.651527663088356648e-03,1.296449215524360099e-01,2.601156069364161938e-02,4.128819157720891621e-04,6.812551610239471825e-03,1.265483071841453366e-01,0.000000000000000000e+00
|
151 |
+
9.145334434351774788e-02,5.800990916597852792e-02,7.225433526011561247e-02,1.143682906688687079e-01,1.651527663088356648e-03,7.390586292320396045e-02,1.748554913294797786e-01,2.683732452518579684e-02,1.713459950454170044e-02,9.496284062758051162e-03,2.993393889347646664e-02,1.075557390586292378e-01,1.176713459950454177e-02,2.477291494632534972e-03,2.270850536746490608e-03,6.668042939719240336e-02,5.140379851362510133e-02,1.445086705202312067e-03,1.383154417836498715e-02,2.621800165152766288e-02,0.000000000000000000e+00
|
152 |
+
6.668042939719240336e-02,2.351362510322047850e-01,6.606110652353426593e-03,3.303055326176713297e-03,3.096614368290668932e-03,1.290255986787778586e-01,1.094137076796036258e-02,9.083402146985962433e-03,2.270850536746490608e-03,9.991742361684557983e-02,8.381502890173410381e-02,2.270850536746490608e-02,1.833195706028075966e-01,8.257638315441783242e-04,1.032204789430222905e-03,6.606110652353426593e-03,1.713459950454170044e-02,3.303055326176713297e-03,1.052848885218827385e-02,5.450041288191577460e-02,0.000000000000000000e+00
|
153 |
+
4.748142031379025581e-03,1.651527663088356648e-03,1.238645747316267486e-03,8.257638315441783242e-04,6.193228736581337431e-04,2.270850536746490608e-03,1.651527663088356648e-03,1.445086705202312067e-03,2.064409578860445810e-04,1.368703550784475531e-01,1.924029727497935660e-01,2.064409578860445810e-03,4.523121387283237094e-01,2.869529314616019872e-02,1.651527663088356648e-03,1.651527663088356648e-03,1.445086705202312067e-03,4.128819157720891621e-03,3.509496284062758095e-03,9.805945499587118142e-02,0.000000000000000000e+00
|
154 |
+
5.842279108175062186e-02,3.474401321222130301e-01,8.464079273327828473e-03,9.083402146985962433e-03,1.032204789430222905e-03,2.952105697770437617e-02,1.531791907514450934e-01,9.496284062758051162e-03,1.527663088356730030e-02,1.796036333608587790e-02,1.112716763005780346e-01,1.023947151114781157e-01,4.954582989265069945e-03,2.477291494632534972e-03,1.857968620974401229e-03,2.332782824112304004e-02,9.083402146985962433e-03,1.651527663088356648e-03,3.509496284062758095e-03,1.899256812551610232e-02,0.000000000000000000e+00
|
155 |
+
8.876961189099917549e-02,2.848885218827415522e-02,1.118909991742361720e-01,4.066886870355078398e-02,1.857968620974401229e-03,2.229562345169281562e-02,5.862923203963666535e-02,4.004954582989265349e-02,1.568951279933938903e-02,6.399669694467382229e-03,2.828241123038810825e-02,6.585466556564822938e-02,5.780346820809248269e-03,4.128819157720891621e-03,1.238645747316267486e-03,1.300578034682080830e-01,2.431874483897605299e-01,2.064409578860445810e-04,7.638315441783650149e-03,1.032204789430223035e-02,0.000000000000000000e+00
|
156 |
+
3.385631709331131389e-02,7.225433526011560553e-03,1.672171758876961345e-02,2.497935590421139496e-02,2.332782824112304004e-02,1.321222130470685319e-02,1.321222130470685319e-02,4.436416184971098131e-01,4.954582989265069945e-03,4.500412881915771823e-02,4.830718414533443500e-02,1.238645747316267573e-02,2.270850536746490608e-03,1.857968620974401229e-03,1.857968620974401229e-03,1.940545004128819279e-02,4.541701073492981217e-03,2.064409578860445810e-04,2.683732452518579770e-03,6.110652353426920119e-02,0.000000000000000000e+00
|
157 |
+
4.479768786127167474e-02,2.518579686209743845e-02,2.993393889347646664e-02,2.043765483071841374e-02,1.527663088356730030e-02,3.881090008257638557e-02,1.195293146160198161e-01,1.672171758876961345e-02,7.431874483897604917e-03,1.899256812551610232e-02,1.589595375722543252e-02,4.376548307184145031e-02,4.335260115606935985e-03,2.683732452518579770e-03,3.303055326176713297e-03,3.447563996696944438e-02,4.768786127167629757e-02,6.193228736581337431e-04,3.715937241948802459e-03,4.727497935590421058e-02,0.000000000000000000e+00
|
158 |
+
2.332782824112304004e-02,1.052848885218827385e-02,9.909165978530139890e-03,2.725020644095788730e-02,2.890173410404624135e-03,5.573905862923203905e-03,1.424442609413707761e-02,1.465730800990916634e-02,3.715937241948802459e-03,1.651527663088356648e-02,3.715937241948802372e-02,1.011560693641618512e-02,1.837324525185796836e-02,3.488852188274153832e-02,7.431874483897604917e-03,1.383154417836498715e-02,1.094137076796036258e-02,1.205615194054500405e-01,5.470685383980181810e-02,1.754748142031379091e-02,0.000000000000000000e+00
|
159 |
+
2.601156069364161938e-02,8.464079273327828473e-03,1.321222130470685319e-02,3.654004954582989323e-02,2.270850536746490608e-03,5.078447563996697084e-02,2.539223781998348542e-02,1.259289843104871923e-02,7.431874483897604917e-03,8.257638315441783242e-03,9.496284062758051162e-03,1.486374896779520983e-02,2.064409578860445810e-03,1.857968620974401229e-03,4.582989265070189916e-02,1.692815854665565695e-02,9.083402146985962433e-03,1.651527663088356648e-03,6.812551610239471825e-03,3.261767134599504597e-02,0.000000000000000000e+00
|
160 |
+
3.220478943022295898e-02,4.748142031379025581e-03,5.573905862923203905e-03,1.052848885218827385e-02,1.238645747316267486e-03,4.541701073492981217e-03,1.300578034682080969e-02,1.156069364161849654e-02,2.890173410404624135e-03,1.052848885218827385e-02,3.509496284062758095e-03,1.032204789430223035e-02,1.238645747316267486e-03,3.922378199834847257e-03,9.289843104872005930e-03,2.353426919900908354e-02,7.018992568125516189e-03,1.238645747316267486e-03,1.238645747316267486e-03,1.383154417836498715e-02,0.000000000000000000e+00
|
161 |
+
5.573905862923203905e-03,1.857968620974401229e-03,6.193228736581337431e-04,3.303055326176713297e-03,4.128819157720891621e-04,3.096614368290668932e-03,7.225433526011560553e-03,5.780346820809248269e-03,2.477291494632534972e-03,2.064409578860445810e-03,1.651527663088356648e-03,3.922378199834847257e-03,0.000000000000000000e+00,2.064409578860445810e-03,2.890173410404624135e-03,2.064409578860445810e-03,2.477291494632534972e-03,1.445086705202312067e-03,5.388109000825763717e-02,6.399669694467382229e-03,0.000000000000000000e+00
|
162 |
+
3.096614368290668932e-03,6.606110652353426593e-03,3.922378199834847257e-03,3.509496284062758095e-03,1.857968620974401229e-03,3.715937241948802459e-03,4.128819157720891621e-03,3.715937241948802459e-03,0.000000000000000000e+00,4.128819157720891621e-04,1.857968620974401229e-03,1.630883567299752299e-02,6.193228736581337431e-04,1.445086705202312067e-03,3.096614368290668932e-03,3.096614368290668932e-03,1.032204789430222905e-03,0.000000000000000000e+00,3.922378199834847257e-03,1.857968620974401229e-03,0.000000000000000000e+00
|
163 |
+
1.032204789430222905e-03,2.064409578860445810e-04,5.161023947151115177e-03,8.257638315441783242e-04,4.128819157720891621e-04,6.193228736581337431e-04,1.238645747316267486e-03,2.291494632535094958e-02,2.064409578860445810e-04,2.064409578860445810e-04,6.193228736581337431e-04,8.257638315441783242e-04,0.000000000000000000e+00,1.445086705202312067e-03,4.128819157720891621e-04,6.193228736581337431e-04,4.128819157720891621e-04,0.000000000000000000e+00,0.000000000000000000e+00,8.257638315441783242e-04,0.000000000000000000e+00
|
164 |
+
1.238645747316267486e-03,2.064409578860445810e-04,0.000000000000000000e+00,4.128819157720891621e-04,0.000000000000000000e+00,0.000000000000000000e+00,2.064409578860445810e-04,4.128819157720891621e-04,0.000000000000000000e+00,1.032204789430222905e-03,1.692815854665565695e-02,1.651527663088356648e-03,0.000000000000000000e+00,1.857968620974401229e-03,0.000000000000000000e+00,8.257638315441783242e-04,1.238645747316267486e-03,4.128819157720891621e-04,1.238645747316267486e-03,3.303055326176713297e-03,0.000000000000000000e+00
|