Skip to content
Snippets Groups Projects

Compare revisions

Changes are shown as if the source revision was being merged into the target revision. Learn more about comparing revisions.

Source

Select target project
No results found
Select Git revision
  • chat
  • kru0052-master-patch-91081
  • lifecycle
  • master
  • 20180621-before_revision
  • 20180621-revision
6 results

Target

Select target project
  • sccs/docs.it4i.cz
  • soj0018/docs.it4i.cz
  • lszustak/docs.it4i.cz
  • jarosjir/docs.it4i.cz
  • strakpe/docs.it4i.cz
  • beranekj/docs.it4i.cz
  • tab0039/docs.it4i.cz
  • davidciz/docs.it4i.cz
  • gui0013/docs.it4i.cz
  • mrazek/docs.it4i.cz
  • lriha/docs.it4i.cz
  • it4i-vhapla/docs.it4i.cz
  • hol0598/docs.it4i.cz
  • sccs/docs-it-4-i-cz-fumadocs
  • siw019/docs-it-4-i-cz-fumadocs
15 results
Select Git revision
  • MPDATABenchmark
  • Urx
  • anselm2
  • hot_fix
  • john_branch
  • master
  • mkdocs_update
  • patch-1
  • pbs
  • salomon_upgrade
  • tabs
  • virtual_environment2
  • 20180621-before_revision
  • 20180621-revision
14 results
Show changes
Showing
with 3456 additions and 0 deletions
# Overview
A human NGS data processing solution.
## Introduction
The scope of this OMICS MASTER solution is restricted to human genomics research (disease causing gene discovery in the whole human genome or exome) or diagnosis (panel sequencing), although it could be extended to other usages in the future.
The pipeline inputs the raw data produced by the sequencing machines and undergoes a processing procedure that consists of a quality control, the mapping and variant calling steps that result in a file containing the set of variants in the sample. From this point, the prioritization component or the diagnostic component can be launched.
![OMICS MASTER solution overview. Data is produced in the external labs and comes to IT4I (represented by the blue dashed line). The data pre-processor converts raw data into a list of variants and annotations for each sequenced patient. These lists files together with primary and secondary (alignment) data files are stored in IT4I sequence DB and uploaded to the discovery (candidate priorization) or diagnostic component where they can be analysed directly by the user that produced
them, depending of the experimental design carried out.](../../../img/fig1.png)
Figure 1. OMICS MASTER solution overview. Data is produced in the external labs and comes to IT4I (represented by the blue dashed line). The data pre-processor converts raw data into a list of variants and annotations for each sequenced patient. These lists files together with primary and secondary (alignment) data files are stored in IT4I sequence DB and uploaded to the discovery (candidate prioritization) or diagnostic component where they can be analyzed directly by the user that produced them, depending of the experimental design carried out.
Typical genomics pipelines are composed by several components that need to be launched manually. The advantage of OMICS MASTER pipeline is that all these components are invoked sequentially in an automated way.
OMICS MASTER pipeline inputs a FASTQ file and outputs an enriched VCF file. This pipeline is able to queue all the jobs by only launching a process taking all the necessary input files and creates the intermediate and final folders
Let us see each of the OMICS MASTER solution components:
## Components
### Processing
This component is composed by a set of programs that carry out quality controls, alignment, realignment, variant calling and variant annotation. It turns raw data from the sequencing machine into files containing lists of variants (VCF) that once annotated, can be used by the following components (discovery and diagnosis).
We distinguish three types of sequencing instruments: bench sequencers (MySeq, IonTorrent, and Roche Junior, although the last one is being discontinued), which produce relatively Genomes in the clinic.
Low throughput (tens of million reads), and high-end sequencers, which produce high throughput (hundreds of million reads) among which we have Illumina HiSeq 2000 (and new models) and SOLiD. All of them but SOLiD produce data in sequence format. SOLiD produces data in a special format called color space that require specific software for the mapping process. Once the mapping has been done, the rest of the pipeline is identical. SOLiD is a technology which is also being discontinued by the manufacturer, so this type of data will be scarce in the future.
#### Quality Control, Preprocessing and Statistics for FASTQ
FastQC& FastQC.
These steps are carried out over the original FASTQ file with optimized scripts and includes the following steps: sequence cleansing, estimation of base quality scores, elimination of duplicates, and statistics.
Input: FASTQ file.
Output: FASTQ file plus an HTML file containing statistics on the data.
FASTQ format represents the nucleotide sequence and its corresponding quality scores.
![FASTQ file.](../../../img/fig2.png)
Figure 2.FASTQ file.
#### Mapping
Component: Hpg-aligner.
Sequence reads are mapped over the human reference genome. SOLiD reads are not covered by this solution; they should be mapped with specific software (among the few available options, SHRiMP seems to be the best one). For the rest of NGS machine outputs we use HPG Aligner. HPG-Aligner is an innovative solution, based on a combination of mapping with BWT and local alignment with Smith-Waterman (SW), that drastically increases mapping accuracy (97% versus 62-70% by current mappers, in the most common scenarios). This proposal provides a simple and fast solution that maps almost all the reads, even those containing a high number of mismatches or indels.
Input: FASTQ file.
Output: Aligned file in BAM format.
#### Sequence Alignment/Map (SAM)
It is a human readable tab-delimited format in which each read and its alignment is represented on a single line. The format can represent unmapped reads, reads that are mapped to unique locations, and reads that are mapped to multiple locations.
The SAM format (1) consists of one header section and one alignment section. The lines in the header section start with the ‘@’ character, and lines in the alignment section do not. All lines are TAB delimited.
In SAM, each alignment line has 11 mandatory fields and a variable number of optional fields. The mandatory fields are briefly described in Table 1. They must be present but their value can be a ‘\’ or a zero (depending on the field) if the
corresponding information is unavailable.
| No. | Name | Description |
| --------- | ---------- | ----------------------------------------------------- |
| 1 | QNAME | Query NAME of the read or the read pai |
| 2 | FLAG | Bitwise FLAG (pairing,strand,mate strand,etc.) |
| 3 | RNAME | Reference sequence NAME |
| 4 | POS | 1-Based leftmost POSition of clipped alignment |
| 5 | MAPQ | MAPping Quality (Phred-scaled) |
| 6 | CIGAR | Extended CIGAR string (operations:MIDNSHP) |
| 7 | MRNM | Mate REference NaMe ('=' if same RNAME) |
| 8 | MPOS | 1-Based leftmost Mate POSition |
| 9 | ISIZE | Inferred Insert SIZE |
| 10 | SEQ | Query SEQuence on the same strand as the reference |
| 11 | QUAL | Query QUALity (ASCII-33=Phred base quality) |
Table 1. Mandatory fields in the SAM format.
The standard CIGAR description of pairwise alignment defines three operations: ‘M’ for match/mismatch, ‘I’ for insertion compared with the reference and ‘D’ for deletion. The extended CIGAR proposed in SAM added four more operations: ‘N’ for skipped bases on the reference, ‘S’ for soft clipping, ‘H’ for hard clipping and ‘P’ for padding. These support splicing, clipping, multi-part and padded alignments. Figure 3 shows examples of CIGAR strings for different types of alignments.
![SAM format file. The ‘@SQ’ line in the header section gives the order of reference sequences. Notably, r001 is the name of a read pair. According to FLAG 163 (=1+2+32+128), the read mapped to position 7 is the second read in the pair (128) and regarded as properly paired (1 + 2); its mate is mapped to 37 on the reverse strand (32). Read r002 has three soft-clipped (unaligned) bases. The coordinate shown in SAM is the position of the first aligned base. The CIGAR string for this alignment contains a P (padding) operation which correctly aligns the inserted sequences. Padding operations can be absent when an aligner does not support multiple sequence alignment. The last six bases of read r003 map to position 9, and the first five to position 29 on the reverse strand. The hard clipping operation H indicates that the clipped sequence is not present in the sequence field. The NM tag gives the number of mismatches. Read r004 is aligned across an intron, indicated by the N operation.](../../../img/fig3.png)
Figure 3. SAM format file. The ‘@SQ’ line in the header section gives the order of reference sequences. Notably, r001 is the name of a read pair. According to FLAG 163 (=1+2+32+128), the read mapped to position 7 is the second read in the pair (128) and regarded as properly paired (1 + 2); its mate is mapped to 37 on the reverse strand (32). Read r002 has three soft-clipped (unaligned) bases. The coordinate shown in SAM is the position of the first aligned base. The CIGAR string for this alignment contains a P (padding) operation, which correctly aligns the inserted sequences. Padding operations can be absent when an aligner does not support multiple sequence alignment. The last six bases of read r003 map to position 9, and the first five to position 29 on the reverse strand. The hard clipping operation H indicates that the clipped sequence is not present in the sequence field. The NM tag gives the number of mismatches. Read r004 is aligned across an intron, indicated by the N operation.
##### Binary Alignment/Map (BAM)
BAM is the binary representation of SAM and keeps exactly the same information as SAM. BAM uses lossless compression to reduce the size of the data by about 75% and provides an indexing system that allows reads that overlap a region of the genome to be retrieved and rapidly traversed.
#### Quality Control, Preprocessing and Statistics for BAM
Component: Hpg-Fastq & FastQC.
Some features
Quality control
reads with N errors
reads with multiple mappings
strand bias
paired-end insert
Filtering: by number of errors, number of hits
Comparator: stats, intersection, etc.
Input: BAM file.
Output: BAM file plus an HTML file containing statistics.
#### Variant Calling
Component: GATK.
Identification of single nucleotide variants and indels on the alignments is performed using the Genome Analysis Toolkit (GATK). GATK (2) is a software package developed at the Broad Institute to analyze high-throughput sequencing data. The toolkit offers a wide variety of tools, with a primary focus on variant discovery and genotyping as well as strong emphasis on data quality assurance.
Input: BAM
Output:VCF
Variant Call Format (VCF)
VCF (3) is a standardized format for storing the most prevalent types of sequence variation, including SNPs, indels and larger structural variants, together with rich annotations. The format was developed with the primary intention to represent human genetic variation, but its use is not restricted to diploid genomes and can be used in different contexts as well. Its flexibility and user extensibility allows representation of a wide variety of genomic variation with respect to a single reference sequence.
A VCF file consists of a header section and a data section. The header contains an arbitrary number of metainformation lines, each starting with characters ‘##’, and a TAB delimited field definition line, starting with a single ‘#’ character. The meta-information header lines provide a standardized description of tags and annotations used in the data section. The use of meta-information allows the information stored within a VCF file to be tailored to the dataset in question. It can be also used to provide information about the means of file creation, date of creation, version of the reference sequence, software used and any other information relevant to the history of the file. The field definition line names eight mandatory columns, corresponding to data columns representing the chromosome (CHROM), a 1-based position of the start of the variant (POS), unique identifiers of the variant (ID), the reference allele (REF), a comma separated list of alternate non-reference alleles (ALT), a phred-scaled quality score (QUAL), site filtering information (FILTER) and a semicolon separated list of additional, user extensible annotation (INFO). In addition, if samples are present in the file, the mandatory header columns are followed by a FORMAT column and an arbitrary number of sample IDs that define the samples included in the VCF file. The FORMAT column is used to define the information contained within each subsequent genotype column, which consists of a colon separated list of fields. For example, the FORMAT field GT:GQ:DP in the fourth data entry of Figure 1a indicates that the subsequent entries contain information regarding the genotype, genotype quality and read depth for each sample. All data lines are TAB delimited and the number of fields in each data line must match the number of fields in the header line. It is strongly recommended that all annotation tags used are declared in the VCF header section.
![a) Example of valid VCF. The header lines ##fileformat and #CHROM are mandatory, the rest is optional but strongly recommended. Each line of the body describes variants present in the sampled population at one genomic position or region. All alternate alleles are listed in the ALT column and referenced from the genotype fields as 1-based indexes to this list; the reference haplotype is designated as 0. For multiploid data, the separator indicates whether the data are phased (|) or unphased (/). Thus, the two alleles C and G at the positions 2 and 5 in this figure occur on the same chromosome in SAMPLE1. The first data line shows an example of a deletion (present in SAMPLE1) and a replacement of two bases by another base (SAMPLE2); the second line shows a SNP and an insertion; the third a SNP; the fourth a large structural variant described by the annotation in the INFO column, the coordinate is that of the base before the variant. (b–f ) Alignments and VCF representations of different sequence variants: SNP, insertion, deletion, replacement, and a large deletion. The REF columns shows the reference bases replaced by the haplotype in the ALT column. The coordinate refers to the first reference base. (g) Users are advised to use simplest representation possible and lowest coordinate in cases where the position is ambiguous.](../../../img/fig4.png)
Figure 4 . (a) Example of valid VCF. The header lines ##fileformat and #CHROM are mandatory, the rest is optional but strongly recommended. Each line of the body describes variants present in the sampled population at one genomic position or region. All alternate alleles are listed in the ALT column and referenced from the genotype fields as 1-based indexes to this list; the reference haplotype is designated as 0. For multiploid data, the separator indicates whether the data are phased (|) or unphased (/). Thus, the two alleles C and G at the positions 2 and 5 in this figure occur on the same chromosome in SAMPLE1. The first data line shows an example of a deletion (present in SAMPLE1) and a replacement of two bases by another base (SAMPLE2); the second line shows a SNP and an insertion; the third a SNP; the fourth a large structural variant described by the annotation in the INFO column, the coordinate is that of the base before the variant. (b–f ) Alignments and VCF representations of different sequence variants: SNP, insertion, deletion, replacement, and a large deletion. The REF columns shows the reference bases replaced by the haplotype in the ALT column. The coordinate refers to the first reference base. (g) Users are advised to use simplest representation possible and lowest coordinate in cases where the position is ambiguous.
### Annotating
Component: HPG-Variant
The functional consequences of every variant found are then annotated using the HPG-Variant software, which extracts from CellBase, the Knowledge database, all the information relevant on the predicted pathologic effect of the variants.
VARIANT (VARIant Analysis Tool) (4) reports information on the variants found that include consequence type and annotations taken from different databases and repositories (SNPs and variants from dbSNP and 1000 genomes, and disease-related variants from the Genome-Wide Association Study (GWAS) catalog, Online Mendelian Inheritance in Man (OMIM), Catalog of Somatic Mutations in Cancer (COSMIC) mutations, etc. VARIANT also produces a rich variety of annotations that include information on the regulatory (transcription factor or miRNAbinding sites, etc.) or structural roles, or on the selective pressures on the sites affected by the variation. This information allows extending the conventional reports beyond the coding regions and expands the knowledge on the contribution of non-coding or synonymous variants to the phenotype studied.
Input: VCF
Output: The output of this step is the Variant Calling Format (VCF) file, which contains changes with respect to the reference genome with the corresponding QC and functional annotations.
#### CellBase
CellBase(5) is a relational database integrates biological information from different sources and includes:
Core features
We took genome sequences, genes, transcripts, exons, cytobands or cross references (xrefs) identifiers (IDs) from Ensembl (6). Protein information including sequences, xrefs or protein features (natural variants, mutagenesis sites, post-translational modifications, etc.) were imported from UniProt (7).
Regulatory
CellBase imports miRNA from miRBase (8); curated and non-curated miRNA targets from miRecords (9), miRTarBase (10),
TargetScan(11) and microRNA.org (12) and CpG islands and conserved regions from the UCSC database (13).
Functional annotation
OBO Foundry (14) develops many biomedical ontologies that are implemented in OBO format. We designed a SQL schema to store these OBO ontologies and 30 ontologies were imported. OBO ontology term annotations were taken from Ensembl (6). InterPro (15) annotations were also imported.
Variation
CellBase includes SNPs from dbSNP (16)^; SNP population frequencies from HapMap (17), 1000 genomes project (18) and Ensembl (6); phenotypically annotated SNPs were imported from NHRI GWAS Catalog (19),HGMD (20), Open Access GWAS Database (21), UniProt (7) and OMIM (22); mutations from COSMIC (23) and structural variations from Ensembl (6).
Systems biology
We also import systems biology information like interactome information from IntAct (24). Reactome (25) stores pathway and interaction information in BioPAX (26) format. BioPAX data exchange format enables the integration of diverse pathway
resources. We successfully solved the problem of storing data released in BioPAX format into a SQL relational schema, which allowed us importing Reactome in CellBase.
### Diagnostic Component (TEAM)
More detail [here][1].
### Priorization Component (BiERApp)
More detail [here][2].
## Usage
First, we should load ngsPipeline module:
```console
$ ml ngsPipeline
```
This command will load python/2.7.5 module and all the required modules (hpg-aligner, gatk, etc)
If we launch ngsPipeline with ‘-h’, we will get the usage help:
```console
$ ngsPipeline -h
Usage: ngsPipeline.py [-h] -i INPUT -o OUTPUT -p PED --project PROJECT --queue
QUEUE [--stages-path STAGES_PATH] [--email EMAIL]
[--prefix PREFIX] [-s START] [-e END] --log
Python pipeline
optional arguments:
-h, --help show this help message and exit
-i INPUT, --input INPUT
-o OUTPUT, --output OUTPUT
Output Data directory
-p PED, --ped PED Ped file with all individuals
--project PROJECT Project Id
--queue QUEUE Queue Id
--stages-path STAGES_PATH
Custom Stages path
--email EMAIL Email
--prefix PREFIX Prefix name for Queue Jobs name
-s START, --start START
Initial stage
-e END, --end END Final stage
--log Log to file
```
Let us see a brief description of the arguments:
```console
-h --help. Show the help.
-i, --input. The input data directory. This directory must to have a special structure. We have to create one folder per sample (with the same name). These folders will host the fastq files. These fastq files must have the following pattern “sampleName” + “_” + “1 or 2” + “.fq”. 1 for the first pair (in paired-end sequences), and 2 for the
second one.
-o , --output. The output folder. This folder will contain all the intermediate and final folders. When the pipeline will be executed completely, we could remove the intermediate folders and keep only the final one (with the VCF file containing all the variants)
-p , --ped. The ped file with the pedigree. This file contains all the sample names. These names must coincide with the names of the input folders. If our input folder contains more samples than the .ped file, the pipeline will use only the samples from the .ped file.
--email. Email for notifications.
--prefix. Prefix for Job names.
-s, --start & -e, --end. Initial and final stage. If we want to launch the pipeline in a specific stage we must use -s. If we want to end the pipeline in a specific stage we must use -e.
--log. Using log argument NGSpipeline will prompt all the logs to this file.
--project>. Project ID of your supercomputer allocation.
--queue. [Queue][3] to run the jobs in.
```
Input, output and ped arguments are mandatory. If the output folder does not exist, the pipeline will create it.
## Examples
This is an example usage of NGSpipeline:
We have a folder with the following structure in
```console
/apps/bio/omics/1.0/sample_data/ >:
/apps/bio/omics/1.0/sample_data
└── data
├── file.ped
├── sample1
│ ├── sample1_1.fq
│ └── sample1_2.fq
└── sample2
├── sample2_1.fq
└── sample2_2.fq
```
The ped file (file.ped) contains the following info:
```console
#family_ID sample_ID parental_ID maternal_ID sex phenotype
FAM sample_A 0 0 1 1
FAM sample_B 0 0 2 2
```
Now, let us load the NGSPipeline module and copy the sample data to a [scratch directory][4]:
```console
$ ml ngsPipeline
$ mkdir -p /scratch/$USER/omics/results
$ cp -r /apps/bio/omics/1.0/sample_data /scratch/$USER/omics/
```
Now, we can launch the pipeline (replace OPEN-0-0 with your Project ID):
```console
$ ngsPipeline -i /scratch/$USER/omics/sample_data/data -o /scratch/$USER/omics/results -p /scratch/$USER/omics/sample_data/data/file.ped --project OPEN-0-0 --queue qprod
```
This command submits the processing [jobs to the queue][5].
If we want to re-launch the pipeline from stage 4 until stage 20, we should use the next command:
```console
$ ngsPipeline -i /scratch/$USER/omics/sample_data/data -o /scratch/$USER/omics/results -p /scratch/$USER/omics/sample_data/data/file.ped -s 4 -e 20 --project OPEN-0-0 --queue qprod
```
## Details on the Pipeline
The pipeline calls the following tools
[fastqc][a], quality control tool for high throughput sequence data.
[gatk][b], The Genome Analysis Toolkit or GATK is a software package developed at the Broad Institute to analyze high-throughput sequencing data. The toolkit offers a wide variety of tools, with a primary focus on variant discovery and genotyping as well as strong emphasis on data quality assurance. Its robust architecture, powerful processing engine and high-performance computing features make it capable of taking on projects of any size.
[hpg-aligner][c], HPG Aligner has been designed to align short and long reads with high sensitivity, therefore any number of mismatches or indels are allowed. HPG Aligner implements and combines two well known algorithms: _Burrows-Wheeler Transform_ (BWT) to speed-up mapping high-quality reads, and _Smith-Waterman_> (SW) to increase sensitivity when reads cannot be mapped using BWT.
[hpg-fastq][d], a quality control tool for high throughput sequence data.
[hpg-variant][e], The HPG Variant suite is an ambitious project aimed to provide a complete suite of tools to work with genomic variation data, from VCF tools to variant profiling or genomic statistics. It is being implemented using High Performance Computing technologies to provide the best performance possible.
[picard][f], Picard comprises Java-based command-line utilities that manipulate SAM files, and a Java API (HTSJDK) for creating new programs that read and write SAM files. Both SAM text format and SAM binary (BAM) format are supported.
[samtools][g], SAM Tools provide various utilities for manipulating alignments in the SAM format, including sorting, merging, indexing and generating alignments in a per-position format.
[snpEff][h], Genetic variant annotation and effect prediction toolbox.
This listing show which tools are used in each step of the pipeline
stage-00: fastqc
stage-01: hpg_fastq
stage-02: fastqc
stage-03: hpg_aligner and samtools
stage-04: samtools
stage-05: samtools
stage-06: fastqc
stage-07: picard
stage-08: fastqc
stage-09: picard
stage-10: gatk
stage-11: gatk
stage-12: gatk
stage-13: gatk
stage-14: gatk
stage-15: gatk
stage-16: samtools
stage-17: samtools
stage-18: fastqc
stage-19: gatk
stage-20: gatk
stage-21: gatk
stage-22: gatk
stage-23: gatk
stage-24: hpg-variant
stage-25: hpg-variant
stage-26: snpEff
stage-27: snpEff
stage-28: hpg-variant
## Interpretation
The output folder contains all the subfolders with the intermediate data. This folder contains the final VCF with all the variants. This file can be uploaded into [TEAM][1] by using the VCF file button. It is important to note here that the entire management of the VCF file is local: no patient’s sequence data is sent over the Internet thus avoiding any problem of data privacy or confidentiality.
![TEAM upload panel. Once the file has been uploaded, a panel must be chosen from the Panel list. Then, pressing the Run button the diagnostic process starts.]\((../../img/fig7.png)
Figure 7. _TEAM upload panel._ _Once the file has been uploaded, a panel must be chosen from the Panel_ list. Then, pressing the Run button the diagnostic process starts.
Once the file has been uploaded, a panel must be chosen from the Panel list. Then, pressing the Run button the diagnostic process starts. TEAM searches first for known diagnostic mutation(s) taken from four databases: HGMD-public (20), [HUMSAVAR][i], ClinVar (29) and COSMIC (23).
![The panel manager. The elements used to define a panel are (A) disease terms, (B) diagnostic mutations and (C) genes. Arrows represent actions that can be taken in the panel manager. Panels can be defined by using the known mutations and genes of a particular disease. This can be done by dragging them to the Primary Diagnostic box (action D). This action, in addition to defining the diseases in the Primary Diagnostic box, automatically adds the corresponding genes to the Genes box. The panels can be customized by adding new genes (action F) or removing undesired genes (action G). New disease mutations can be added independently or associated to an already existing disease term (action E). Disease terms can be removed by simply dragging them back (action H).](../../../img/fig7x.png)
Figure 7. The panel manager. The elements used to define a panel are ( A ) disease terms, ( B ) diagnostic mutations and ( C ) genes. Arrows represent actions that can be taken in the panel manager. Panels can be defined by using the known mutations and genes of a particular disease. This can be done by dragging them to the Primary Diagnostic box (action D). This action, in addition to defining the diseases in the Primary Diagnostic box, automatically adds the corresponding genes to the Genes box. The panels can be customized by adding new genes (action F) or removing undesired genes (action G). New disease mutations can be added independently or associated to an already existing disease term (action E). Disease terms can be removed by simply dragging them back (action H).
For variant discovering/filtering we should upload the VCF file into BierApp by using the following form:
![BierApp VCF upload panel. It is recommended to choose a name for the job as well as a description.](../../../img/fig8.png)\
Figure 8. \BierApp VCF upload panel. It is recommended to choose a name for the job as well as a description \\.
Each prioritization (‘job’) has three associated screens that facilitate the filtering steps. The first one, the ‘Summary’ tab, displays a statistic of the data set analyzed, containing the samples analyzed, the number and types of variants found and its distribution according to consequence types. The second screen, in the ‘Variants and effect’ tab, is the actual filtering tool, and the third one, the ‘Genome view’ tab, offers a representation of the selected variants within the genomic context provided by an embedded version of the Genome Maps Tool (30).
![This picture shows all the information associated to the variants. If a variant has an associated phenotype we could see it in the last column. In this case, the variant 7:132481242 CT is associated to the phenotype: large intestine tumor.](../../../img/fig9.png)
Figure 9. This picture shows all the information associated to the variants. If a variant has an associated phenotype we could see it in the last column. In this case, the variant 7:132481242 CT is associated to the phenotype: large intestine tumor.
## References
1. Heng Li, Bob Handsaker, Alec Wysoker, Tim Fennell, Jue Ruan, Nils Homer, Gabor Marth5, Goncalo Abecasis6, Richard Durbin and 1000 Genome Project Data Processing Subgroup: The Sequence Alignment/Map format and SAMtools. Bioinformatics 2009, 25: 2078-2079.
1. McKenna A, Hanna M, Banks E, Sivachenko A, Cibulskis K, Kernytsky A, Garimella K, Altshuler D, Gabriel S, Daly M, DePristo MA: The Genome Analysis Toolkit: a MapReduce framework for analyzing next-generation DNA sequencing data. _Genome Res_ >2010, 20:1297-1303.
1. Petr Danecek, Adam Auton, Goncalo Abecasis, Cornelis A. Albers, Eric Banks, Mark A. DePristo, Robert E. Handsaker, Gerton Lunter, Gabor T. Marth, Stephen T. Sherry, Gilean McVean, Richard Durbin, and 1000 Genomes Project Analysis Group. The variant call format and VCFtools. Bioinformatics 2011, 27: 2156-2158.
1. Medina I, De Maria A, Bleda M, Salavert F, Alonso R, Gonzalez CY, Dopazo J: VARIANT: Command Line, Web service and Web interface for fast and accurate functional characterization of variants found by Next-Generation Sequencing. Nucleic Acids Res 2012, 40:W54-58.
1. Bleda M, Tarraga J, de Maria A, Salavert F, Garcia-Alonso L, Celma M, Martin A, Dopazo J, Medina I: CellBase, a comprehensive collection of RESTful web services for retrieving relevant biological information from heterogeneous sources. Nucleic Acids Res 2012, 40:W609-614.
1. Flicek,P., Amode,M.R., Barrell,D., Beal,K., Brent,S., Carvalho-Silva,D., Clapham,P., Coates,G., Fairley,S., Fitzgerald,S. et al. (2012) Ensembl 2012. Nucleic Acids Res., 40, D84–D90.
1. UniProt Consortium. (2012) Reorganizing the protein space at the Universal Protein Resource (UniProt). Nucleic Acids Res., 40, D71–D75.
1. Kozomara,A. and Griffiths-Jones,S. (2011) miRBase: integrating microRNA annotation and deep-sequencing data. Nucleic Acids Res., 39, D152–D157.
1. Xiao,F., Zuo,Z., Cai,G., Kang,S., Gao,X. and Li,T. (2009) miRecords: an integrated resource for microRNA-target interactions. Nucleic Acids Res., 37, D105–D110.
1. Hsu,S.D., Lin,F.M., Wu,W.Y., Liang,C., Huang,W.C., Chan,W.L., Tsai,W.T., Chen,G.Z., Lee,C.J., Chiu,C.M. et al. (2011) miRTarBase: a database curates experimentally validated microRNA-target interactions. Nucleic Acids Res., 39, D163–D169.
1. Friedman,R.C., Farh,K.K., Burge,C.B. and Bartel,D.P. (2009) Most mammalian mRNAs are conserved targets of microRNAs. Genome Res., 19, 92–105. 12. Betel,D., Wilson,M., Gabow,A., Marks,D.S. and Sander,C. (2008) The microRNA.org resource: targets and expression. Nucleic Acids Res., 36, D149–D153.
1. Dreszer,T.R., Karolchik,D., Zweig,A.S., Hinrichs,A.S., Raney,B.J., Kuhn,R.M., Meyer,L.R., Wong,M., Sloan,C.A., Rosenbloom,K.R. et al. (2012) The UCSC genome browser database: extensions and updates 2011. Nucleic Acids Res.,40, D918–D923.
1. Smith,B., Ashburner,M., Rosse,C., Bard,J., Bug,W., Ceusters,W., Goldberg,L.J., Eilbeck,K., Ireland,A., Mungall,C.J. et al. (2007) The OBO Foundry: coordinated evolution of ontologies to support biomedical data integration. Nat. Biotechnol., 25, 1251–1255.
1. Hunter,S., Jones,P., Mitchell,A., Apweiler,R., Attwood,T.K.,Bateman,A., Bernard,T., Binns,D., Bork,P., Burge,S. et al. (2012) InterPro in 2011: new developments in the family and domain prediction database. Nucleic Acids Res.,40, D306–D312.
1. Sherry,S.T., Ward,M.H., Kholodov,M., Baker,J., Phan,L., Smigielski,E.M. and Sirotkin,K. (2001) dbSNP: the NCBI database of genetic variation. Nucleic Acids Res., 29, 308–311.
1. Altshuler,D.M., Gibbs,R.A., Peltonen,L., Dermitzakis,E., Schaffner,S.F., Yu,F., Bonnen,P.E., de Bakker,P.I., Deloukas,P., Gabriel,S.B. et al. (2010) Integrating common and rare genetic variation in diverse human populations. Nature, 467, 52–58.
1. 1000 Genomes Project Consortium. (2010) A map of human genome variation from population-scale sequencing. Nature, 467, 1061–1073.
1. Hindorff,L.A., Sethupathy,P., Junkins,H.A., Ramos,E.M., Mehta,J.P., Collins,F.S. and Manolio,T.A. (2009) Potential etiologic and functional implications of genome-wide association loci for human diseases and traits. Proc. Natl Acad. Sci. USA, 106, 9362–9367.
1. Stenson,P.D., Ball,E.V., Mort,M., Phillips,A.D., Shiel,J.A., Thomas,N.S., Abeysinghe,S., Krawczak,M. and Cooper,D.N. (2003) Human gene mutation database (HGMD): 2003 update. Hum. Mutat., 21, 577–581.
1. Johnson,A.D. and O’Donnell,C.J. (2009) An open access database of genome-wide association results. BMC Med. Genet, 10, 6.
1. McKusick,V. (1998) A Catalog of Human Genes and Genetic Disorders, 12th edn. John Hopkins University Press,Baltimore, MD.
1. Forbes,S.A., Bindal,N., Bamford,S., Cole,C., Kok,C.Y., Beare,D., Jia,M., Shepherd,R., Leung,K., Menzies,A. et al. (2011) COSMIC: mining complete cancer genomes in the catalogue of somatic mutations in cancer. Nucleic Acids Res., 39, D945–D950.
1. Kerrien,S., Aranda,B., Breuza,L., Bridge,A., Broackes-Carter,F., Chen,C., Duesbury,M., Dumousseau,M., Feuermann,M., Hinz,U. et al. (2012) The Intact molecular interaction database in 2012. Nucleic Acids Res., 40, D841–D846.
1. Croft,D., O’Kelly,G., Wu,G., Haw,R., Gillespie,M., Matthews,L., Caudy,M., Garapati,P., Gopinath,G., Jassal,B. et al. (2011) Reactome: a database of reactions, pathways and biological processes. Nucleic Acids Res., 39, D691–D697.
1. Demir,E., Cary,M.P., Paley,S., Fukuda,K., Lemer,C., Vastrik,I.,Wu,G., D’Eustachio,P., Schaefer,C., Luciano,J. et al. (2010) The BioPAX community standard for pathway data sharing. Nature Biotechnol., 28, 935–942.
1. Alemán Z, García-García F, Medina I, Dopazo J (2014): A web tool for the design and management of panels of genes for targeted enrichment and massive sequencing for clinical applications. Nucleic Acids Res 42: W83-7.
1. [Alemán A][j], [Garcia-Garcia F][k], [Salavert F][l], [Medina I][m], [Dopazo J][n] (2014). A web-based interactive framework to assist in the prioritization of disease candidate genes in whole-exome sequencing studies. [Nucleic Acids Res.][o], W88-93.
1. Landrum,M.J., Lee,J.M., Riley,G.R., Jang,W., Rubinstein,W.S., Church,D.M. and Maglott,D.R. (2014) ClinVar: public archive of relationships among sequence variation and human phenotype. Nucleic Acids Res., 42, D980–D985.
1. Medina I, Salavert F, Sanchez R, de Maria A, Alonso R, Escobar P, Bleda M, Dopazo J: Genome Maps, a new generation genome browser. Nucleic Acids Res 2013, 41:W41-46.
[1]: diagnostic-component-team.md
[2]: priorization-component-bierapp.md
[3]: ../../../general/resources-allocation-policy.md
[4]: ../../../salomon/storage.md
[5]: ../../../general/job-submission-and-execution.md
[a]: http://www.bioinformatics.babraham.ac.uk/projects/fastqc/
[b]: https://www.broadinstitute.org/gatk/
[c]: https://github.com/opencb-hpg/hpg-aligner
[d]: http://docs.bioinfo.cipf.es/projects/fastqhpc/wiki
[e]: http://docs.bioinfo.cipf.es/projects/hpg-variant/wiki
[f]: http://picard.sourceforge.net/
[g]: http://samtools.sourceforge.net/samtools-c.shtml
[h]: http://snpeff.sourceforge.net/
[i]: http://www.uniprot.org/docs/humsavar
[j]: http://www.ncbi.nlm.nih.gov/pubmed?term=Alem%C3%A1n%20A%5BAuthor%5D&cauthor=true&cauthor_uid=24803668
[k]: http://www.ncbi.nlm.nih.gov/pubmed?term=Garcia-Garcia%20F%5BAuthor%5D&cauthor=true&cauthor_uid=24803668
[l]: http://www.ncbi.nlm.nih.gov/pubmed?term=Salavert%20F%5BAuthor%5D&cauthor=true&cauthor_uid=24803668
[m]: http://www.ncbi.nlm.nih.gov/pubmed?term=Medina%20I%5BAuthor%5D&cauthor=true&cauthor_uid=24803668
[n]: http://www.ncbi.nlm.nih.gov/pubmed?term=Dopazo%20J%5BAuthor%5D&cauthor=true&cauthor_uid=24803668
[o]: http://www.ncbi.nlm.nih.gov/pubmed/?term=BiERapp
# Prioritization Component (BiERapp)
## Access
BiERapp is available at the [following address][1].
!!! note
The address is accessible only via VPN.
## BiERapp
** This tool is aimed at discovering new disease genes or variants by studying affected families or cases and controls. It carries out a filtering process to sequentially remove: (i) variants which are not compatible with the disease because they are not expected to have impact on the protein function; (ii) variants that exist at frequencies incompatible with the disease; (iii) variants that do not segregate with the disease. The result is a reduced set of disease gene candidates that should be further validated experimentally. **
BiERapp (28) efficiently helps in the identification of causative variants in family and sporadic genetic diseases. The program reads lists of predicted variants (nucleotide substitutions and indels) in affected individuals or tumor samples and controls. In family studies, different modes of inheritance can easily be defined to filter out variants that do not segregate with the disease along the family. Moreover, BiERapp integrates additional information such as allelic frequencies in the general population and the most popular damaging scores to further narrow down the number of putative variants in successive filtering steps. BiERapp provides an interactive and user-friendly interface that implements the filtering strategy used in the context of a large-scale genomic project carried out by the Spanish Network for Research, in Rare Diseases (CIBERER), and the Medical Genome Project. in which more than 800 exomes have been analyzed.
![Web interface to the prioritization tool. This figure shows the interface of the web tool for candidate gene prioritization with the filters available. The tool includes a genomic viewer (Genome Maps 30) that enables the representation of the variants in the corresponding genomic coordinates.](../../../img/fig6.png)
**Figure 6**. Web interface to the prioritization tool. This figure shows the interface of the web tool for candidate gene
prioritization with the filters available. The tool includes a genomic viewer (Genome Maps 30) that enables the representation of the variants in the corresponding genomic coordinates.
[1]: http://omics.it4i.cz/bierapp/
# COMSOL Multiphysics
## Introduction
[COMSOL][a] is a powerful environment for modelling and solving various engineering
and scientific problems based on partial differential equations.
COMSOL is designed to solve coupled or multiphysics phenomena.
For many standard engineering problems, COMSOL provides add-on products (modules)
such as electrical, mechanical, fluid flow, and chemical applications.
* [Structural Mechanics Module][b],
* [Heat Transfer Module][c],
* [CFD Module][d],
* [Acoustics Module][e].
* and [many others][f]
COMSOL also allows an interface support for equation-based modelling of partial differential equations.
## Execution
There are two types of license:
* **Non commercial** or so called **EDU variant**, which can be used for research and educational purposes.
* **Commercial** or so called **COM variant**, which can used also for commercial activities. **COM variant** has only subset of features compared to the **EDU variant** available. More about licensing [here][1].
By default, the **EDU variant** is loaded. If you needs other version or variant, load the particular version. To obtain the list of available versions, use:
```console
$ ml av COMSOL
```
To prepare COMSOL jobs in the interactive mode, we recommend using COMSOL on the compute nodes.
!!! Note
To run the COMSOL Desktop GUI on Windows, we recommend using the [Virtual Network Computing (VNC)][2].
Example for Karolina:
```console
$srun --account=PROJECT_ID --partition=qcpu --nodes=1 --ntasks=128 --cpus-per-task=1 --x11
$ ml av COMSOL
------------------------------ /apps/modules/phys -----------------------------
COMSOL/5.2.0-COM COMSOL/5.2.0-EDU (D)
$ ml COMSOL/5.2.0-EDU
$ comsol -3drend sw
```
* If you receive errors at startup, for example, of the following type:
```console
FL3D: error at line 814 in file fl3dglcontext_x11common.c:
PBuffers are not supported by the system.
FL3D: error at line 235 in file fl3dglcontext_x11common.c:
assert: x11Handle
```
you need to run COMSOL with additional parameters:
```console
$ comsol -3drend sw
```
To run COMSOL in batch mode without the COMSOL Desktop GUI environment,
utilize the following (`comsol.slurm`) job script and execute it via the `salloc` command:
```bash
#!/bin/bash
#SBATCH --nodes=3
#SBATCH --ntasks-per-node=128
#SBATCH --cpus-per-task=1
#SBATCH --partition=qcpu
#SBATCH --job-name=JOB_NAME
#SBATCH --account=PROJECT_ID
cd /scratch/project/PROJECT_ID/ || exit
echo Time is `date`
echo Directory is `pwd`
echo '**SLURM_JOB_NODELIST***START*******'
scontrol show hostname $SLURM_JOB_NODELIST
echo '**SLURM_JOB_NODELIST***END*********'
# Assign the number of tasks
ntask=$(scontrol show hostname $SLURM_JOB_NODELIST | wc -l)
# Load COMSOL module
ml COMSOL/5.2.0-EDU
# Run COMSOL with SLURM options
comsol -3drend sw -nn ${ntask} batch -configuration /tmp \
–mpiarg –rmk –mpiarg slurm \
-tmpdir /scratch/project/PROJECT_ID/ \
-inputfile name_input_f.mph \
-outputfile name_output_f.mph \
-batchlog name_log_f.log
```
A working directory has to be created before sending the (`comsol.slurm`) job script into the queue.
The input file (name_input_f.mph) has to be in the working directory
or a full path to the input file has to be specified.
The appropriate path to the temp directory of the job has to be set by the `-tmpdir` command option.
### Starting a COMSOL Server
Starting a COMSOL server on a compute node and then connecting to it
through a COMSOL Desktop GUI environment is a convenient way of running calculations from GUI.
To do so, you first need to submit a job with which you'll start the COMSOL server, for example:
!!! Note
You may be prompted to provide username and password. These can be different from your IT4Innovations credentials, and will be used during the authentication when trying to connect to the server from GUI.
```bash
$ salloc --account=PROJECT_ID --partition=qcpu_exp --nodes=1 --ntasks=36 --cpus-per-task=1
salloc: Granted job allocation 694746
salloc: Waiting for resource configuration
salloc: Nodes cn58 are ready for job
$ ml COMSOL/5.2.0-COM
$ comsol server
COMSOL 5.2 (Build: 166) Multiphysics Server started listening on port 2036
Use the console command 'close' to exit the program
```
After that, start your COMSOL Desktop GUI session and fill required information under `File -> Client Server -> Connect to Server`, where server will be the node where COMSOL server is running. Once you are done, your computational tasks will be offloaded to the COMSOL server.
## LiveLink for MATLAB
COMSOL is a software package for the numerical solution of partial differential equations. LiveLink for MATLAB allows connection to the COMSOL API (Application Programming Interface) with the benefits of the programming language and computing environment of MATLAB.
LiveLink for MATLAB is available in both **EDU** and **COM** **variant** of the COMSOL release. On the clusters there is 1 commercial (**COM**) and 5 educational (**EDU**) licenses of LiveLink for MATLAB (see the [ISV Licenses][3]). The following example shows how to start COMSOL model from MATLAB via LiveLink in the interactive mode.
```console
salloc --account=PROJECT_ID --partition=qcpu_exp --nodes=1 --ntasks=128 --cpus-per-task=1 --x11
$ ml <matlab_module> and <comsol_module>
$ comsol -3drend sw server MATLAB
```
On the first start of the LiveLink for MATLAB (client-MATLAB/server-COMSOL connection), the login and password is requested; this information is not requested again.
To run LiveLink for MATLAB in batch mode with (`comsol_matlab.slurm`) job script,
you can utilize/modify the following script and execute it via the `sbatch` command.
```bash
#!/bin/bash
#SBATCH --nodes=3
#SBATCH --ntasks-per-node=128
#SBATCH --cpus-per-task=1
#SBATCH --partition=qcpu
#SBATCH --job-name=JOB_NAME
#SBATCH --account=PROJECT_ID
cd /scratch/project/PROJECT_ID || exit
echo Time is `date`
echo Directory is `pwd`
echo '**SLURM_JOB_NODELIST***START*******'
scontrol show hostname $SLURM_JOB_NODELIST
echo '**SLURM_JOB_NODELIST***END*********'
# Assign the number of tasks
ntask=$(scontrol show hostname $SLURM_JOB_NODELIST | wc -l)
# Load modules
ml <matlab_module> and <comsol_module>
# Run with Slurm options
comsol -3drend sw -nn ${ntask} server -configuration /tmp -mpiarg -rmk -mpiarg slurm -tmpdir /scratch/project/PROJECT_ID &
cd $EBROOTCOMSOL/mli
matlab -nodesktop -nosplash -r "mphstart; addpath /scratch/project/PROJECT_ID; test_job"
```
This example shows how to run LiveLink for MATLAB with the following configuration:
3 nodes and 128 cores per node. A working directory has to be created
before submitting (`comsol_matlab.slurm`) job script into the queue.
The input file (`test_job.m`) has to be in the working directory
or a full path to the input file has to be specified.
The MATLAB command option (`-r ”mphstart”`) created a connection with a COMSOL server using the default port number.
[1]: licensing-and-available-versions.md
[2]: ../../../general/accessing-the-clusters/graphical-user-interface/vnc.md
[3]: ../../isv_licenses.md
[4]: ../../../modules/lmod/#loading-modules
[a]: http://www.comsol.com
[b]: http://www.comsol.com/structural-mechanics-module
[c]: http://www.comsol.com/heat-transfer-module
[d]: http://www.comsol.com/cfd-module
[e]: http://www.comsol.com/acoustics-module
[f]: http://www.comsol.com/products
# Licensing and Available Versions
## COMSOL License Can Be Used By:
* all persons carrying out the CE IT4Innovations Project (In addition to the primary licensee, which is VSB - Technical University of Ostrava, users are CE IT4Innovations third parties - CE IT4Innovations project partners, particularly the University of Ostrava, the Brno University of Technology - Faculty of Informatics, the Silesian University in Opava, Institute of Geonics AS CR.);
* all persons who have a valid license;
* students of the Technical University.
## COMSOL Network License Types
| Type | Description |
| ---- | ----------- |
| EDU | Academic license for science and research, publications, students’ projects, and teaching. |
| COM | Commercial license for science and research, publications, students’ projects, and commercial research with no commercial use restrictions. Enables the solution of at least one job by one user in one program start. |
## Available Versions
See the [list of available licenses][a].
[a]: http://licelin.it4i.cz/list/
\ No newline at end of file
# taken from https://nwchemgit.github.io/Sample.html
start h2o
title "Water in 6-31g basis set"
geometry units au
O 0.00000000 0.00000000 0.00000000
H 0.00000000 1.43042809 -1.10715266
H 0.00000000 -1.43042809 -1.10715266
end
basis
H library 6-31g
O library 6-31g
end
task scf
PREC = Accurate
IBRION = -1
ENCUT = 500
EDIFF = 1.0e-08
ISMEAR = 0
SIGMA = 0.01
IALGO = 38
LREAL = .FALSE.
ADDGRID = .TRUE.
LWAVE = .FALSE.
LCHARG = .FALSE.
NCORE = 8
KPAR = 8
Automatic mesh
0
Monkhorst Pack
3 3 3
0.5 0.5 0.5
Si
1.0
5.4335600309153529 0.0000000000000000 0.0000000000000000
0.0000000000000000 5.4335600309153529 0.0000000000000000
0.0000000000000000 0.0000000000000000 5.4335600309153529
Si
8
Direct
0.8750000000000000 0.8750000000000000 0.8750000000000000
0.8750000000000000 0.3750000000000000 0.3750000000000000
0.3750000000000000 0.8750000000000000 0.3750000000000000
0.3750000000000000 0.3750000000000000 0.8750000000000000
0.1250000000000000 0.1250000000000000 0.1250000000000000
0.1250000000000000 0.6250000000000000 0.6250000000000000
0.6250000000000000 0.1250000000000000 0.6250000000000000
0.6250000000000000 0.6250000000000000 0.1250000000000000
PAW_PBE Si 05Jan2001
4.00000000000000
parameters from PSCTR are:
VRHFIN =Si: s2p2
LEXCH = PE
EATOM = 103.0669 eV, 7.5752 Ry
TITEL = PAW_PBE Si 05Jan2001
LULTRA = F use ultrasoft PP ?
IUNSCR = 1 unscreen: 0-lin 1-nonlin 2-no
RPACOR = 1.500 partial core radius
POMASS = 28.085; ZVAL = 4.000 mass and valenz
RCORE = 1.900 outmost cutoff radius
RWIGS = 2.480; RWIGS = 1.312 wigner-seitz radius (au A)
ENMAX = 245.345; ENMIN = 184.009 eV
ICORE = 2 local potential
LCOR = T correct aug charges
LPAW = T paw PP
EAUG = 322.069
DEXC = 0.000
RMAX = 1.950 core radius for proj-oper
RAUG = 1.300 factor for augmentation sphere
RDEP = 1.993 radius for radial grids
RDEPT = 1.837 core radius for aug-charge
Atomic configuration
6 entries
n l j E occ.
1 0 0.50 -1785.8828 2.0000
2 0 0.50 -139.4969 2.0000
2 1 1.50 -95.5546 6.0000
3 0 0.50 -10.8127 2.0000
3 1 0.50 -4.0811 2.0000
3 2 1.50 -4.0817 0.0000
Description
l E TYP RCUT TYP RCUT
0 -10.8127223 23 1.900
0 -7.6451159 23 1.900
1 -4.0811372 23 1.900
1 2.4879257 23 1.900
2 -4.0817478 7 1.900
Error from kinetic energy argument (eV)
NDATA = 100
STEP = 20.000 1.050
10.1 9.04 8.56 7.65 7.23 6.44 5.73 5.40
4.79 4.25 4.00 3.54 3.13 2.77 2.45 2.16
1.91 1.69 1.50 1.24 1.10 0.975 0.812 0.718
0.636 0.529 0.440 0.388 0.322 0.266 0.219 0.180
0.148 0.121 0.986E-01 0.804E-01 0.614E-01 0.504E-01 0.392E-01 0.328E-01
0.265E-01 0.220E-01 0.189E-01 0.166E-01 0.149E-01 0.135E-01 0.123E-01 0.109E-01
0.977E-02 0.840E-02 0.707E-02 0.605E-02 0.488E-02 0.387E-02 0.290E-02 0.229E-02
0.185E-02 0.152E-02 0.134E-02 0.125E-02 0.121E-02 0.117E-02 0.112E-02 0.102E-02
0.915E-03 0.776E-03 0.640E-03 0.524E-03 0.425E-03 0.369E-03 0.331E-03 0.310E-03
0.294E-03 0.273E-03 0.242E-03 0.210E-03 0.175E-03 0.146E-03 0.124E-03 0.113E-03
0.105E-03 0.973E-04 0.879E-04 0.755E-04 0.633E-04 0.539E-04 0.478E-04 0.438E-04
0.404E-04 0.362E-04 0.308E-04 0.264E-04 0.229E-04 0.209E-04 0.192E-04 0.170E-04
0.145E-04 0.126E-04 0.112E-04 0.103E-04
END of PSCTR-controll parameters
local part
98.2657514061040
0.84157827E+01 0.84210738E+01 0.84276982E+01 0.84387529E+01 0.84542581E+01
0.84742396E+01 0.84987267E+01 0.85277503E+01 0.85613408E+01 0.85995259E+01
0.86423293E+01 0.86897698E+01 0.87418601E+01 0.87986073E+01 0.88600119E+01
0.89260684E+01 0.89967646E+01 0.90720817E+01 0.91519931E+01 0.92364635E+01
0.93254478E+01 0.94188892E+01 0.95167180E+01 0.96188495E+01 0.97251831E+01
0.98356006E+01 0.99499656E+01 0.10068122E+02 0.10189896E+02 0.10315092E+02
0.10443494E+02 0.10574869E+02 0.10708960E+02 0.10845494E+02 0.10984175E+02
0.11124688E+02 0.11266699E+02 0.11409854E+02 0.11553782E+02 0.11698093E+02
0.11842379E+02 0.11986220E+02 0.12129179E+02 0.12270807E+02 0.12410647E+02
0.12548229E+02 0.12683078E+02 0.12814715E+02 0.12942655E+02 0.13066413E+02
0.13185507E+02 0.13299453E+02 0.13407778E+02 0.13510011E+02 0.13605696E+02
0.13694386E+02 0.13775649E+02 0.13849071E+02 0.13914257E+02 0.13970832E+02
0.14018447E+02 0.14056776E+02 0.14085521E+02 0.14104413E+02 0.14113214E+02
0.14111717E+02 0.14099750E+02 0.14077174E+02 0.14043887E+02 0.13999823E+02
0.13944953E+02 0.13879287E+02 0.13802871E+02 0.13715791E+02 0.13618172E+02
0.13510174E+02 0.13391995E+02 0.13263871E+02 0.13126072E+02 0.12978902E+02
0.12822701E+02 0.12657837E+02 0.12484712E+02 0.12303752E+02 0.12115414E+02
0.11920177E+02 0.11718542E+02 0.11511032E+02 0.11298186E+02 0.11080557E+02
0.10858712E+02 0.10633228E+02 0.10404687E+02 0.10173679E+02 0.99407916E+01
0.97066145E+01 0.94717325E+01 0.92367246E+01 0.90021610E+01 0.87686002E+01
0.85365875E+01 0.83066515E+01 0.80793028E+01 0.78550311E+01 0.76343038E+01
0.74175639E+01 0.72052283E+01 0.69976864E+01 0.67952987E+01 0.65983955E+01
0.64072761E+01 0.62222079E+01 0.60434255E+01 0.58711305E+01 0.57054914E+01
0.55466428E+01 0.53946864E+01 0.52496904E+01 0.51116908E+01 0.49806913E+01
0.48566647E+01 0.47395535E+01 0.46292714E+01 0.45257040E+01 0.44287107E+01
0.43381259E+01 0.42537609E+01 0.41754051E+01 0.41028283E+01 0.40357824E+01
0.39740032E+01 0.39172126E+01 0.38651205E+01 0.38174269E+01 0.37738239E+01
0.37339980E+01 0.36976316E+01 0.36644057E+01 0.36340010E+01 0.36061008E+01
0.35803917E+01 0.35565662E+01 0.35343243E+01 0.35133744E+01 0.34934356E+01
0.34742386E+01 0.34555273E+01 0.34370594E+01 0.34186082E+01 0.33999625E+01
0.33809283E+01 0.33613289E+01 0.33410051E+01 0.33198163E+01 0.32976400E+01
0.32743723E+01 0.32499276E+01 0.32242386E+01 0.31972561E+01 0.31689481E+01
0.31393000E+01 0.31083133E+01 0.30760055E+01 0.30424088E+01 0.30075693E+01
0.29715464E+01 0.29344112E+01 0.28962459E+01 0.28571426E+01 0.28172018E+01
0.27765317E+01 0.27352466E+01 0.26934661E+01 0.26513137E+01 0.26089155E+01
0.25663991E+01 0.25238926E+01 0.24815235E+01 0.24394172E+01 0.23976965E+01
0.23564804E+01 0.23158831E+01 0.22760134E+01 0.22369739E+01 0.21988601E+01
0.21617599E+01 0.21257533E+01 0.20909117E+01 0.20572975E+01 0.20249639E+01
0.19939549E+01 0.19643047E+01 0.19360380E+01 0.19091702E+01 0.18837070E+01
0.18596451E+01 0.18369721E+01 0.18156671E+01 0.17957010E+01 0.17770369E+01
0.17596305E+01 0.17434311E+01 0.17283815E+01 0.17144192E+01 0.17014767E+01
0.16894823E+01 0.16783606E+01 0.16680337E+01 0.16584212E+01 0.16494414E+01
0.16410120E+01 0.16330503E+01 0.16254746E+01 0.16182040E+01 0.16111597E+01
0.16042653E+01 0.15974473E+01 0.15906355E+01 0.15837638E+01 0.15767703E+01
0.15695978E+01 0.15621942E+01 0.15545124E+01 0.15465111E+01 0.15381545E+01
0.15294125E+01 0.15202610E+01 0.15106817E+01 0.15006618E+01 0.14901946E+01
0.14792787E+01 0.14679181E+01 0.14561220E+01 0.14439045E+01 0.14312843E+01
0.14182845E+01 0.14049320E+01 0.13912573E+01 0.13772941E+01 0.13630790E+01
0.13486508E+01 0.13340503E+01 0.13193195E+01 0.13045019E+01 0.12896413E+01
0.12747816E+01 0.12599667E+01 0.12452398E+01 0.12306429E+01 0.12162169E+01
0.12020007E+01 0.11880315E+01 0.11743438E+01 0.11609698E+01 0.11479386E+01
0.11352766E+01 0.11230067E+01 0.11111486E+01 0.10997185E+01 0.10887293E+01
0.10781901E+01 0.10681067E+01 0.10584812E+01 0.10493126E+01 0.10405963E+01
0.10323245E+01 0.10244864E+01 0.10170684E+01 0.10100541E+01 0.10034245E+01
0.99715842E+00 0.99123278E+00 0.98562260E+00 0.98030147E+00 0.97524176E+00
0.97041492E+00 0.96579177E+00 0.96134272E+00 0.95703813E+00 0.95284851E+00
0.94874481E+00 0.94469866E+00 0.94068261E+00 0.93667036E+00 0.93263699E+00
0.92855911E+00 0.92441506E+00 0.92018508E+00 0.91585139E+00 0.91139837E+00
0.90681257E+00 0.90208284E+00 0.89720031E+00 0.89215846E+00 0.88695307E+00
0.88158221E+00 0.87604623E+00 0.87034764E+00 0.86449105E+00 0.85848310E+00
0.85233228E+00 0.84604885E+00 0.83964467E+00 0.83313304E+00 0.82652853E+00
0.81984678E+00 0.81310436E+00 0.80631854E+00 0.79950711E+00 0.79268821E+00
0.78588011E+00 0.77910103E+00 0.77236900E+00 0.76570163E+00 0.75911595E+00
0.75262828E+00 0.74625406E+00 0.74000769E+00 0.73390245E+00 0.72795034E+00
0.72216201E+00 0.71654666E+00 0.71111201E+00 0.70586419E+00 0.70080779E+00
0.69594576E+00 0.69127948E+00 0.68680873E+00 0.68253171E+00 0.67844512E+00
0.67454419E+00 0.67082277E+00 0.66727336E+00 0.66388728E+00 0.66065470E+00
0.65756482E+00 0.65460595E+00 0.65176565E+00 0.64903085E+00 0.64638804E+00
0.64382333E+00 0.64132264E+00 0.63887182E+00 0.63645681E+00 0.63406371E+00
0.63167898E+00 0.62928953E+00 0.62688282E+00 0.62444703E+00 0.62197109E+00
0.61944485E+00 0.61685909E+00 0.61420564E+00 0.61147745E+00 0.60866857E+00
0.60577426E+00 0.60279097E+00 0.59971637E+00 0.59654936E+00 0.59329001E+00
0.58993961E+00 0.58650059E+00 0.58297648E+00 0.57937187E+00 0.57569237E+00
0.57194448E+00 0.56813556E+00 0.56427372E+00 0.56036773E+00 0.55642691E+00
0.55246106E+00 0.54848032E+00 0.54449508E+00 0.54051586E+00 0.53655323E+00
0.53261770E+00 0.52871958E+00 0.52486894E+00 0.52107546E+00 0.51734836E+00
0.51369633E+00 0.51012743E+00 0.50664899E+00 0.50326761E+00 0.49998904E+00
0.49681819E+00 0.49375905E+00 0.49081466E+00 0.48798714E+00 0.48527765E+00
0.48268635E+00 0.48021249E+00 0.47785436E+00 0.47560937E+00 0.47347400E+00
0.47144395E+00 0.46951410E+00 0.46767862E+00 0.46593101E+00 0.46426418E+00
0.46267051E+00 0.46114196E+00 0.45967012E+00 0.45824631E+00 0.45686165E+00
0.45550718E+00 0.45417389E+00 0.45285284E+00 0.45153526E+00 0.45021257E+00
0.44887651E+00 0.44751921E+00 0.44613322E+00 0.44471163E+00 0.44324809E+00
0.44173687E+00 0.44017292E+00 0.43855189E+00 0.43687018E+00 0.43512494E+00
0.43331410E+00 0.43143638E+00 0.42949128E+00 0.42747908E+00 0.42540083E+00
0.42325834E+00 0.42105410E+00 0.41879135E+00 0.41647393E+00 0.41410629E+00
0.41169346E+00 0.40924092E+00 0.40675463E+00 0.40424087E+00 0.40170626E+00
0.39915764E+00 0.39660202E+00 0.39404651E+00 0.39149826E+00 0.38896435E+00
0.38645179E+00 0.38396739E+00 0.38151775E+00 0.37910915E+00 0.37674752E+00
0.37443839E+00 0.37218682E+00 0.36999739E+00 0.36787410E+00 0.36582042E+00
0.36383920E+00 0.36193268E+00 0.36010247E+00 0.35834954E+00 0.35667423E+00
0.35507622E+00 0.35355459E+00 0.35210779E+00 0.35073369E+00 0.34942958E+00
0.34819223E+00 0.34701790E+00 0.34590241E+00 0.34484115E+00 0.34382917E+00
0.34286120E+00 0.34193171E+00 0.34103498E+00 0.34016513E+00 0.33931621E+00
0.33848221E+00 0.33765717E+00 0.33683518E+00 0.33601049E+00 0.33517751E+00
0.33433089E+00 0.33346559E+00 0.33257685E+00 0.33166032E+00 0.33071204E+00
0.32972848E+00 0.32870659E+00 0.32764378E+00 0.32653800E+00 0.32538767E+00
0.32419176E+00 0.32294975E+00 0.32166166E+00 0.32032801E+00 0.31894983E+00
0.31752862E+00 0.31606638E+00 0.31456552E+00 0.31302889E+00 0.31145970E+00
0.30986149E+00 0.30823814E+00 0.30659375E+00 0.30493266E+00 0.30325937E+00
0.30157850E+00 0.29989478E+00 0.29821295E+00 0.29653774E+00 0.29487384E+00
0.29322581E+00 0.29159810E+00 0.28999494E+00 0.28842037E+00 0.28687815E+00
0.28537173E+00 0.28390425E+00 0.28247850E+00 0.28109688E+00 0.27976142E+00
0.27847372E+00 0.27723499E+00 0.27604598E+00 0.27490705E+00 0.27381811E+00
0.27277867E+00 0.27178782E+00 0.27084424E+00 0.26994624E+00 0.26909178E+00
0.26827846E+00 0.26750359E+00 0.26676420E+00 0.26605705E+00 0.26537872E+00
0.26472559E+00 0.26409390E+00 0.26347982E+00 0.26287940E+00 0.26228871E+00
0.26170380E+00 0.26112078E+00 0.26053582E+00 0.25994525E+00 0.25934552E+00
0.25873328E+00 0.25810539E+00 0.25745897E+00 0.25679138E+00 0.25610030E+00
0.25538370E+00 0.25463989E+00 0.25386749E+00 0.25306548E+00 0.25223319E+00
0.25137030E+00 0.25047681E+00 0.24955311E+00 0.24859991E+00 0.24761822E+00
0.24660941E+00 0.24557510E+00 0.24451722E+00 0.24343793E+00 0.24233963E+00
0.24122491E+00 0.24009654E+00 0.23895742E+00 0.23781058E+00 0.23665912E+00
0.23550619E+00 0.23435497E+00 0.23320861E+00 0.23207023E+00 0.23094290E+00
0.22982954E+00 0.22873298E+00 0.22765588E+00 0.22660071E+00 0.22556975E+00
0.22456503E+00 0.22358838E+00 0.22264133E+00 0.22172517E+00 0.22084090E+00
0.21998924E+00 0.21917062E+00 0.21838518E+00 0.21763278E+00 0.21691298E+00
0.21622507E+00 0.21556808E+00 0.21494076E+00 0.21434166E+00 0.21376905E+00
0.21322105E+00 0.21269556E+00 0.21219033E+00 0.21170298E+00 0.21123101E+00
0.21077184E+00 0.21032282E+00 0.20988128E+00 0.20944453E+00 0.20900989E+00
0.20857473E+00 0.20813650E+00 0.20769272E+00 0.20724104E+00 0.20677924E+00
0.20630528E+00 0.20581727E+00 0.20531352E+00 0.20479256E+00 0.20425312E+00
0.20369419E+00 0.20311496E+00 0.20251488E+00 0.20189363E+00 0.20125114E+00
0.20058759E+00 0.19990339E+00 0.19919917E+00 0.19847580E+00 0.19773436E+00
0.19697612E+00 0.19620254E+00 0.19541525E+00 0.19461602E+00 0.19380675E+00
0.19298946E+00 0.19216623E+00 0.19133925E+00 0.19051071E+00 0.18968285E+00
0.18885789E+00 0.18803806E+00 0.18722550E+00 0.18642234E+00 0.18563058E+00
0.18485213E+00 0.18408879E+00 0.18334221E+00 0.18261386E+00 0.18190508E+00
0.18121702E+00 0.18055061E+00 0.17990663E+00 0.17928561E+00 0.17868791E+00
0.17811368E+00 0.17756283E+00 0.17703511E+00 0.17653003E+00 0.17604693E+00
0.17558494E+00 0.17514305E+00 0.17472004E+00 0.17431456E+00 0.17392512E+00
0.17355012E+00 0.17318784E+00 0.17283649E+00 0.17249419E+00 0.17215904E+00
0.17182910E+00 0.17150240E+00 0.17117700E+00 0.17085099E+00 0.17052249E+00
0.17018968E+00 0.16985083E+00 0.16950432E+00 0.16914863E+00 0.16878235E+00
0.16840425E+00 0.16801322E+00 0.16760831E+00 0.16718876E+00 0.16675395E+00
0.16630348E+00 0.16583708E+00 0.16535470E+00 0.16485644E+00 0.16434260E+00
0.16381364E+00 0.16327019E+00 0.16271304E+00 0.16214313E+00 0.16156154E+00
0.16096948E+00 0.16036827E+00 0.15975933E+00 0.15914418E+00 0.15852437E+00
0.15790155E+00 0.15727738E+00 0.15665353E+00 0.15603169E+00 0.15541354E+00
0.15480073E+00 0.15419485E+00 0.15359745E+00 0.15300998E+00 0.15243381E+00
0.15187022E+00 0.15132035E+00 0.15078523E+00 0.15026574E+00 0.14976264E+00
0.14927652E+00 0.14880782E+00 0.14835684E+00 0.14792369E+00 0.14750835E+00
0.14711063E+00 0.14673020E+00 0.14636656E+00 0.14601907E+00 0.14568697E+00
0.14536935E+00 0.14506518E+00 0.14477334E+00 0.14449260E+00 0.14422166E+00
0.14395913E+00 0.14370359E+00 0.14345355E+00 0.14320753E+00 0.14296401E+00
0.14272149E+00 0.14247846E+00 0.14223347E+00 0.14198509E+00 0.14173199E+00
0.14147286E+00 0.14120650E+00 0.14093181E+00 0.14064779E+00 0.14035355E+00
0.14004833E+00 0.13973149E+00 0.13940254E+00 0.13906109E+00 0.13870694E+00
0.13833999E+00 0.13796029E+00 0.13756804E+00 0.13716357E+00 0.13674733E+00
0.13631991E+00 0.13588203E+00 0.13543449E+00 0.13497823E+00 0.13451425E+00
0.13404367E+00 0.13356764E+00 0.13308739E+00 0.13260420E+00 0.13211936E+00
0.13163422E+00 0.13115008E+00 0.13066829E+00 0.13019015E+00 0.12971693E+00
0.12924988E+00 0.12879016E+00 0.12833890E+00 0.12789711E+00 0.12746576E+00
0.12704568E+00 0.12663761E+00 0.12624221E+00 0.12585997E+00 0.12549131E+00
0.12513650E+00 0.12479568E+00 0.12446890E+00 0.12415605E+00 0.12385692E+00
0.12357117E+00 0.12329835E+00 0.12303789E+00 0.12278912E+00 0.12255128E+00
0.12232351E+00 0.12210488E+00 0.12189437E+00 0.12169094E+00 0.12149345E+00
0.12130077E+00 0.12111171E+00 0.12092509E+00 0.12073970E+00 0.12055436E+00
0.12036791E+00 0.12017920E+00 0.11998713E+00 0.11979067E+00 0.11958882E+00
0.11938067E+00 0.11916539E+00 0.11894223E+00 0.11871054E+00 0.11846977E+00
0.11821946E+00 0.11795928E+00 0.11768898E+00 0.11740846E+00 0.11711769E+00
0.11681676E+00 0.11650590E+00 0.11618540E+00 0.11585569E+00 0.11551727E+00
0.11517075E+00 0.11481682E+00 0.11445624E+00 0.11408986E+00 0.11371856E+00
0.11334329E+00 0.11296505E+00 0.11258484E+00 0.11220371E+00 0.11182270E+00
0.11144287E+00 0.11106526E+00 0.11069088E+00 0.11032073E+00 0.10995575E+00
0.10959686E+00 0.10924489E+00 0.10890064E+00 0.10856481E+00 0.10823802E+00
0.10792083E+00 0.10761369E+00 0.10731697E+00 0.10703093E+00 0.10675575E+00
0.10649150E+00 0.10623816E+00 0.10599560E+00 0.10576362E+00 0.10554191E+00
0.10533006E+00 0.10512760E+00 0.10493397E+00 0.10474853E+00 0.10457057E+00
0.10439934E+00 0.10423403E+00 0.10407377E+00 0.10391769E+00 0.10376486E+00
0.10361436E+00 0.10346525E+00 0.10331660E+00 0.10316749E+00 0.10301700E+00
0.10286427E+00 0.10270845E+00 0.10254875E+00 0.10238443E+00 0.10221481E+00
0.10203926E+00 0.10185725E+00 0.10166830E+00 0.10147204E+00 0.10126815E+00
0.10105642E+00 0.10083671E+00 0.10060898E+00 0.10037327E+00 0.10012971E+00
0.99878499E-01 0.99619941E-01 0.99354403E-01 0.99082329E-01 0.98804234E-01
0.98520694E-01 0.98232343E-01 0.97939865E-01 0.97643987E-01 0.97345468E-01
0.97045098E-01 0.96743682E-01 0.96442039E-01 0.96140988E-01 0.95841346E-01
0.95543917E-01 0.95249483E-01 0.94958801E-01 0.94672589E-01 0.94391526E-01
0.94116241E-01 0.93847307E-01 0.93585238E-01 0.93330481E-01 0.93083416E-01
0.92844349E-01 0.92613514E-01 0.92391067E-01 0.92177088E-01 0.91971582E-01
0.91774473E-01 0.91585615E-01 0.91404784E-01 0.91231686E-01 0.91065960E-01
0.90907179E-01 0.90754858E-01 0.90608455E-01 0.90467383E-01 0.90331010E-01
0.90198671E-01 0.90069670E-01 0.89943293E-01 0.89818810E-01 0.89695483E-01
0.89572578E-01 0.89449363E-01 0.89325125E-01 0.89199170E-01 0.89070830E-01
0.88939475E-01 0.88804513E-01 0.88665401E-01 0.88521645E-01 0.88372809E-01
0.88218518E-01 0.88058459E-01 0.87892386E-01 0.87720120E-01 0.87541552E-01
0.87356640E-01 0.87165411E-01 0.86967963E-01 0.86764459E-01 0.86555125E-01
0.86340254E-01 0.86120194E-01 0.85895352E-01 0.85666183E-01 0.85433191E-01
0.85196919E-01 0.84957943E-01 0.84716871E-01 0.84474330E-01 0.84230965E-01
0.83987427E-01 0.83744375E-01 0.83502460E-01 0.83262325E-01 0.83024599E-01
0.82789886E-01 0.82558766E-01 0.82331783E-01 0.82109442E-01 0.81892206E-01
0.81680487E-01 0.81474646E-01 0.81274989E-01 0.81081762E-01 0.80895153E-01
0.80715285E-01 0.80542223E-01 0.80375965E-01 0.80216452E-01 0.80063558E-01
0.79917102E-01 0.79776842E-01 0.79642482E-01 0.79513673E-01 0.79390016E-01
0.79271070E-01 0.79156353E-01 0.79045348E-01 0.78937510E-01 0.78832270E-01
0.78729044E-01 0.78627233E-01 0.78526236E-01 0.78425450E-01 0.78324279E-01
0.78222140E-01 0.78118466E-01 0.78012713E-01 0.77904366E-01 0.77792943E-01
0.77678000E-01 0.77559135E-01 0.77435994E-01 0.77308271E-01 0.77175713E-01
0.77038121E-01 0.76895353E-01 0.76747321E-01 0.76593998E-01 0.76435410E-01
0.76271640E-01 0.76102829E-01 0.75929167E-01 0.75750899E-01 0.75568317E-01
gradient corrections used for XC
5
core charge-density (partial)
0.13681949E+01 0.13676959E+01 0.13662000E+01 0.13637104E+01 0.13602324E+01
0.13557734E+01 0.13503428E+01 0.13439523E+01 0.13366153E+01 0.13283472E+01
0.13191654E+01 0.13090891E+01 0.12981392E+01 0.12863383E+01 0.12737106E+01
0.12602819E+01 0.12460793E+01 0.12311313E+01 0.12154677E+01 0.11991193E+01
0.11821181E+01 0.11644969E+01 0.11462894E+01 0.11275300E+01 0.11082538E+01
0.10884961E+01 0.10682931E+01 0.10476808E+01 0.10266956E+01 0.10053741E+01
0.98375262E+00 0.96186755E+00 0.93975498E+00 0.91745072E+00 0.89499016E+00
0.87240821E+00 0.84973922E+00 0.82701686E+00 0.80427411E+00 0.78154316E+00
0.75885532E+00 0.73624100E+00 0.71372964E+00 0.69134965E+00 0.66912839E+00
0.64709210E+00 0.62526589E+00 0.60367368E+00 0.58233822E+00 0.56128101E+00
0.54052235E+00 0.52008128E+00 0.49997557E+00 0.48022176E+00 0.46083511E+00
0.44182966E+00 0.42321818E+00 0.40501223E+00 0.38722214E+00 0.36985705E+00
0.35292494E+00 0.33643261E+00 0.32038576E+00 0.30478900E+00 0.28964586E+00
0.27495885E+00 0.26072948E+00 0.24695831E+00 0.23364497E+00 0.22078821E+00
0.20838595E+00 0.19643529E+00 0.18493257E+00 0.17387344E+00 0.16325283E+00
0.15306506E+00 0.14330386E+00 0.13396239E+00 0.12503331E+00 0.11650882E+00
0.10838067E+00 0.10064023E+00 0.93278518E-01 0.86286246E-01 0.79653843E-01
0.73371502E-01 0.67429213E-01 0.61816795E-01 0.56523931E-01 0.51540200E-01
0.46855106E-01 0.42458107E-01 0.38338646E-01 0.34486172E-01 0.30890172E-01
0.27540190E-01 0.24425849E-01 0.21536878E-01 0.18863124E-01 0.16394576E-01
0.14121382E-01 0.12033859E-01 0.10122515E-01 0.83780585E-02 0.67914089E-02
0.53537106E-02 0.40563407E-02 0.28909176E-02 0.18493085E-02 0.92363542E-03
0.10628041E-03 -0.61011040E-03 -0.12326236E-02 -0.17680763E-02 -0.22230145E-02
-0.26037132E-02 -0.29161761E-02 -0.31661366E-02 -0.33590602E-02 -0.35001461E-02
-0.35943308E-02 -0.36462914E-02 -0.36604499E-02 -0.36409778E-02 -0.35918010E-02
-0.35166057E-02 -0.34188437E-02 -0.33017394E-02 -0.31682955E-02 -0.30213003E-02
-0.28633343E-02 -0.26967779E-02 -0.25238181E-02 -0.23464567E-02 -0.21665170E-02
-0.19856524E-02 -0.18053531E-02 -0.16269545E-02 -0.14516446E-02 -0.12804716E-02
-0.11143515E-02 -0.95407586E-03 -0.80031865E-03 -0.65364404E-03 -0.51451333E-03
-0.38329200E-03 -0.26025655E-03 -0.14560117E-03 -0.39444206E-04 0.58165511E-04
0.14724262E-03 0.22785936E-03 0.30013988E-03 0.36425486E-03 0.42041628E-03
0.46887249E-03 0.50990345E-03 0.54381626E-03 0.57094089E-03 0.59162618E-03
0.60623606E-03 0.61514598E-03 0.61873965E-03 0.61740590E-03 0.61153586E-03
0.60152029E-03 0.58774720E-03 0.57059962E-03 0.55045360E-03 0.52767638E-03
0.50262483E-03 0.47564398E-03 0.44706578E-03 0.41720804E-03 0.38637349E-03
0.35484905E-03 0.32290520E-03 0.29079554E-03 0.25875640E-03 0.22700668E-03
0.19574774E-03 0.16516339E-03 0.13542003E-03 0.10666685E-03 0.79036085E-04
0.52643449E-04 0.27588516E-04 0.39552468E-05 -0.18187463E-04 -0.38785176E-04
-0.57797261E-04 -0.75196218E-04 -0.90966955E-04 -0.10510606E-03 -0.11762103E-03
-0.12852953E-03 -0.13785857E-03 -0.14564378E-03 -0.15192857E-03 -0.15676342E-03
-0.16020506E-03 -0.16231574E-03 -0.16316249E-03 -0.16281640E-03 -0.16135194E-03
-0.15884627E-03 -0.15537858E-03 -0.15102952E-03 -0.14588055E-03 -0.14001345E-03
-0.13350974E-03 -0.12645021E-03 -0.11891448E-03 -0.11098055E-03 -0.10272444E-03
-0.94219805E-04 -0.85537640E-04 -0.76745997E-04 -0.67909725E-04 -0.59090261E-04
-0.50345444E-04 -0.41729365E-04 -0.33292246E-04 -0.25080348E-04 -0.17135911E-04
-0.94971158E-05 -0.21980783E-05 0.47311370E-05 0.11264478E-04 0.17379845E-04
0.23059011E-04 0.28287520E-04 0.33054576E-04 0.37352909E-04 0.41178630E-04
0.44531077E-04 0.47412643E-04 0.49828603E-04 0.51786928E-04 0.53298092E-04
0.54374882E-04 0.55032192E-04 0.55286830E-04 0.55157307E-04 0.54663644E-04
0.53827164E-04 0.52670300E-04 0.51216400E-04 0.49489532E-04 0.47514308E-04
0.45315698E-04 0.42918862E-04 0.40348985E-04 0.37631122E-04 0.34790049E-04
0.31850125E-04 0.28835161E-04 0.25768302E-04 0.22671916E-04 0.19567494E-04
0.16475560E-04 0.13415592E-04 0.10405948E-04 0.74638125E-05 0.46051404E-05
0.18446199E-05 -0.80435987E-06 -0.33297298E-05 -0.57207546E-05 -0.79680364E-05
-0.10063512E-04 -0.12000439E-04 -0.13773380E-04 -0.15378176E-04 -0.16811912E-04
-0.18072879E-04 -0.19160535E-04 -0.20075450E-04 -0.20819257E-04 -0.21394592E-04
-0.21805037E-04 -0.22055053E-04 -0.22149916E-04 -0.22095648E-04 -0.21898950E-04
-0.21567127E-04 -0.21108021E-04 -0.20529939E-04 -0.19841581E-04 -0.19051971E-04
-0.18170386E-04 -0.17206292E-04 -0.16169276E-04 -0.15068979E-04 -0.13915042E-04
-0.12717039E-04 -0.11484427E-04 -0.10226489E-04 -0.89522885E-05 -0.76706185E-05
-0.63899616E-05 -0.51184500E-05 -0.38638298E-05 -0.26334298E-05 -0.14341327E-05
-0.27235182E-06 0.84599001E-06 0.19154766E-05 0.29312116E-05 0.38888274E-05
0.47844916E-05 0.56149086E-05 0.63773189E-05 0.70694951E-05 0.76897347E-05
0.82368496E-05 0.87101542E-05 0.91094492E-05 0.94350049E-05 0.96875409E-05
0.98682048E-05 0.99785487E-05 0.10020504E-04 0.99963566E-05 0.99087169E-05
0.97604941E-05 0.95548658E-05 0.92952492E-05 0.89852707E-05 0.86287363E-05
0.82296016E-05 0.77919421E-05 0.73199235E-05 0.68177737E-05 0.62897538E-05
0.57401314E-05 0.51731542E-05 0.45930246E-05 0.40038757E-05 0.34097487E-05
0.28145712E-05 0.22221377E-05 0.16360907E-05 0.10599042E-05 0.49686836E-06
-0.49924166E-07 -0.57759007E-06 -0.10834657E-05 -0.15651155E-05 -0.20203390E-05
-0.24471762E-05 -0.28439108E-05 -0.32090727E-05 -0.35414380E-05 -0.38400284E-05
-0.41041084E-05 -0.43331817E-05 -0.45269860E-05 -0.46854866E-05 -0.48088687E-05
-0.48975292E-05 -0.49520669E-05 -0.49732720E-05 -0.49621150E-05 -0.49197346E-05
-0.48474252E-05 -0.47466237E-05 -0.46188962E-05 -0.44659240E-05 -0.42894896E-05
-0.40914625E-05 -0.38737847E-05 -0.36384570E-05 -0.33875242E-05 -0.31230617E-05
-0.28471617E-05 -0.25619195E-05 -0.22694215E-05 -0.19717316E-05 -0.16708804E-05
-0.13688531E-05 -0.10675792E-05 -0.76892254E-06 -0.47467176E-06 -0.18653194E-06
0.93883212E-07 0.36505831E-06 0.62558247E-06 0.87415464E-06 0.11095881E-05
0.13308142E-05 0.15368850E-05 0.17269756E-05 0.19003853E-05 0.20565378E-05
0.21949812E-05 0.23153867E-05 0.24175470E-05 0.25013740E-05 0.25668951E-05
0.26142502E-05 0.26436873E-05 0.26555573E-05 0.26503092E-05 0.26284843E-05
0.25907101E-05 0.25376938E-05 0.24702157E-05 0.23891225E-05 0.22953196E-05
0.21897645E-05 0.20734587E-05 0.19474410E-05 0.18127797E-05 0.16705653E-05
0.15219029E-05 0.13679056E-05 0.12096872E-05 0.10483551E-05 0.88500424E-06
0.72071045E-06 0.55652455E-06 0.39346662E-06 0.23252070E-06 0.74629781E-07
-0.79308742E-07 -0.22844727E-06 -0.37199175E-06 -0.50920498E-06 -0.63940955E-06
-0.76199023E-06 -0.87639600E-06 -0.98214161E-06 -0.10788087E-05 -0.11660465E-05
-0.12435720E-05 -0.13111700E-05 -0.13686922E-05 -0.14160566E-05 -0.14532460E-05
-0.14803064E-05 -0.14973448E-05 -0.15045271E-05 -0.15020754E-05 -0.14902650E-05
-0.14694215E-05 -0.14399173E-05 -0.14021680E-05 -0.13566289E-05 -0.13037909E-05
-0.12441768E-05 -0.11783371E-05 -0.11068459E-05 -0.10302970E-05 -0.94929927E-06
-0.86447309E-06 -0.77644589E-06 -0.68584830E-06 -0.59331013E-06 -0.49945664E-06
-0.40490479E-06 -0.31025970E-06 -0.21611131E-06 -0.12303113E-06 -0.31569266E-07
0.57748381E-07 0.14442270E-06 0.22798371E-06 0.30799268E-06 0.38404401E-06
0.45576680E-06 0.52282629E-06 0.58492494E-06 0.64180328E-06 0.69324054E-06
0.73905501E-06 0.77910415E-06 0.81328446E-06 0.84153115E-06 0.86381754E-06
0.88015423E-06 0.89058818E-06 0.89520142E-06 0.89410976E-06 0.88746116E-06
0.87543409E-06 0.85823563E-06 0.83609957E-06 0.80928424E-06 0.77807038E-06
0.74275888E-06 0.70366841E-06 0.66113309E-06 0.61550005E-06 0.56712697E-06
0.51637969E-06 0.46362977E-06 0.40925206E-06 0.35362237E-06 0.29711511E-06
0.24010109E-06 0.18294534E-06 0.12600498E-06 0.69627290E-07 0.14147785E-07
-0.40111519E-07 -0.92843763E-07 -0.14375875E-06 -0.19258430E-06 -0.23906753E-06
-0.28297589E-06 -0.32409810E-06 -0.36224497E-06 -0.39725004E-06 -0.42896999E-06
-0.45728505E-06 -0.48209914E-06 -0.50333992E-06 -0.52095866E-06 -0.53492999E-06
-0.54525153E-06 -0.55194336E-06 -0.55504738E-06 -0.55462655E-06 -0.55076401E-06
-0.54356215E-06 -0.53314150E-06 -0.51963959E-06 -0.50320974E-06 -0.48401975E-06
-0.46225056E-06 -0.43809484E-06 -0.41175556E-06 -0.38344448E-06 -0.35338074E-06
-0.32178927E-06 -0.28889935E-06 -0.25494309E-06 -0.22015396E-06 -0.18476533E-06
-0.14900905E-06 -0.11311407E-06 -0.77305131E-07 -0.41801454E-07 -0.68155504E-08
0.27447935E-07 0.60793293E-07 0.93034747E-07 0.12399737E-06 0.15351790E-06
0.18144551E-06 0.20764241E-06 0.23198445E-06 0.25436152E-06 0.27467799E-06
0.29285292E-06 0.30882025E-06 0.32252891E-06 0.33394274E-06 0.34304047E-06
0.34981548E-06 0.35427553E-06 0.35644240E-06 0.35635150E-06 0.35405130E-06
0.34960280E-06 0.34307888E-06 0.33456360E-06 0.32415144E-06 0.31194653E-06
0.29806180E-06 0.28261810E-06 0.26574328E-06 0.24757132E-06 0.22824131E-06
0.20789656E-06 0.18668361E-06 0.16475126E-06 0.14224963E-06 0.11932923E-06
0.96139992E-07 0.72830423E-07 0.49546690E-07 0.26431790E-07 0.36247474E-08
-0.18740158E-07 -0.40534108E-07 -0.61634419E-07 -0.81925165E-07 -0.10129775E-06
-0.11965140E-06 -0.13689367E-06 -0.15294075E-06 -0.16771790E-06 -0.18115965E-06
-0.19321003E-06 -0.20382275E-06 -0.21296124E-06 -0.22059870E-06 -0.22671807E-06
-0.23131193E-06 -0.23438237E-06 -0.23594075E-06 -0.23600750E-06 -0.23461175E-06
-0.23179103E-06 -0.22759087E-06 -0.22206432E-06 -0.21527153E-06 -0.20727922E-06
-0.19816015E-06 -0.18799254E-06 -0.17685950E-06 -0.16484846E-06 -0.15205046E-06
-0.13855964E-06 -0.12447252E-06 -0.10988739E-06 -0.94903706E-07 -0.79621417E-07
-0.64140371E-07 -0.48559705E-07 -0.32977250E-07 -0.17488964E-07 -0.21883816E-08
0.12833908E-07 0.27490758E-07 0.41698930E-07 0.55379522E-07 0.68458371E-07
0.80866414E-07 0.92540008E-07 0.10342122E-06 0.11345806E-06 0.12260471E-06
0.13082166E-06 0.13807583E-06 0.14434068E-06 0.14959621E-06 0.15382899E-06
0.15703210E-06 0.15920506E-06 0.16035369E-06 0.16048999E-06 0.15963194E-06
0.15780326E-06 0.15503318E-06 0.15135615E-06 0.14681155E-06 0.14144332E-06
0.13529964E-06 0.12843256E-06 0.12089760E-06 0.11275334E-06 0.10406101E-06
0.94884097E-07 0.85287872E-07 0.75338992E-07 0.65105052E-07 0.54654166E-07
0.44054534E-07 0.33374031E-07 0.22679796E-07 0.12037835E-07 0.15126439E-08
-0.88331616E-08 -0.18939192E-07 -0.28747612E-07 -0.38203448E-07 -0.47254869E-07
-0.55853449E-07 -0.63954402E-07 -0.71516784E-07 -0.78503682E-07 -0.84882360E-07
-0.90624389E-07 -0.95705740E-07 -0.10010686E-06 -0.10381269E-06 -0.10681271E-06
-0.10910090E-06 -0.11067571E-06 -0.11153996E-06 -0.11170080E-06 -0.11116954E-06
-0.10996154E-06 -0.10809603E-06 -0.10559592E-06 -0.10248761E-06 -0.98800769E-07
-0.94568084E-07 -0.89825018E-07 -0.84609542E-07 -0.78961861E-07 -0.72924130E-07
-0.66540164E-07 -0.59855141E-07 -0.52915304E-07 -0.45767663E-07 -0.38459689E-07
-0.31039024E-07 -0.23553181E-07 -0.16049264E-07 -0.85736810E-08 -0.11718762E-08
0.61119303E-08 0.13234992E-07 0.20156272E-07 0.26836663E-07 0.33239193E-07
0.39329216E-07 0.45074582E-07 0.50445791E-07 0.55416131E-07 0.59961790E-07
0.64061954E-07 0.67698885E-07 0.70857975E-07 0.73527785E-07 0.75700059E-07
0.77369725E-07 0.78534868E-07 0.79196695E-07 0.79359470E-07 0.79030440E-07
0.78219744E-07 0.76940297E-07 0.75207672E-07 0.73039955E-07 0.70457599E-07
0.67483257E-07 0.64141608E-07 0.60459175E-07 0.56464132E-07 0.52186103E-07
0.47655963E-07 0.42905624E-07 0.37967827E-07 0.32875928E-07 0.27663683E-07
0.22365039E-07 0.17013921E-07 0.11644026E-07 0.62886240E-08 0.98035848E-09
-0.42489404E-08 -0.93684373E-08 -0.14348464E-07 -0.19160680E-07 -0.23778227E-07
-0.28175866E-07 -0.32330105E-07 -0.36219319E-07 -0.39823844E-07 -0.43126075E-07
-0.46110532E-07 -0.48763927E-07 -0.51075207E-07 -0.53035585E-07 -0.54638561E-07
-0.55879923E-07 -0.56757739E-07 -0.57272329E-07 -0.57426230E-07 -0.57224148E-07
-0.56672888E-07 -0.55781290E-07 -0.54560132E-07 -0.53022045E-07 -0.51181396E-07
-0.49054183E-07 -0.46657907E-07 -0.44011441E-07 -0.41134899E-07 -0.38049487E-07
-0.34777363E-07 -0.31341484E-07 -0.27765453E-07 -0.24073368E-07 -0.20289666E-07
-0.16438967E-07 -0.12545925E-07 -0.86350721E-08 -0.47306767E-08 -0.85659471E-09
0.29638671E-08 0.67080858E-08 0.10354249E-07 0.13881476E-07 0.17269932E-07
0.20500930E-07 0.23557030E-07 0.26422126E-07 0.29081523E-07 0.31522008E-07
0.33731903E-07 0.35701119E-07 0.37421188E-07 0.38885294E-07 0.40088290E-07
0.41026701E-07 0.41698723E-07 0.42104208E-07 0.42244641E-07 0.42123104E-07
0.41744237E-07 0.41114183E-07 0.40240531E-07 0.39132246E-07 0.37799597E-07
0.36254071E-07 0.34508287E-07 0.32575904E-07 0.30471520E-07 0.28210569E-07
0.25809215E-07 0.23284245E-07 0.20652955E-07 0.17933036E-07 0.15142464E-07
0.12299384E-07 0.94219950E-08 0.65284431E-08 0.36367075E-08 0.76449490E-09
-0.20708645E-08 -0.48525176E-08 -0.75641838E-08 -0.10190246E-07 -0.12715838E-07
-0.15126919E-07 -0.17410355E-07 -0.19553980E-07 -0.21546658E-07 -0.23378335E-07
-0.25040088E-07 -0.26524159E-07 -0.27823989E-07 -0.28934238E-07 -0.29850803E-07
-0.30570824E-07 -0.31092680E-07 -0.31415990E-07 -0.31541588E-07 -0.31471507E-07
-0.31208949E-07 -0.30758244E-07 -0.30124814E-07 -0.29315120E-07 -0.28336610E-07
-0.27197660E-07 -0.25907508E-07 -0.24476186E-07 -0.22914450E-07 -0.21233701E-07
-0.19445907E-07 -0.17563525E-07 -0.15599414E-07 -0.13566755E-07 -0.11478964E-07
-0.93496047E-08 -0.71923085E-08 -0.50206872E-08 -0.28482512E-08 -0.68832844E-09
0.14460143E-08 0.35420475E-08 0.55874520E-08 0.75703881E-08 0.94795614E-08
0.11304284E-07 0.13034532E-07 0.14660996E-07 0.16175129E-07 0.17569189E-07
0.18836272E-07 0.19970348E-07 0.20966280E-07 0.21819847E-07 0.22527754E-07
0.23087645E-07 0.23498096E-07 0.23758621E-07 0.23869653E-07 0.23832537E-07
0.23649502E-07 0.23323641E-07 0.22858877E-07 0.22259931E-07 0.21532279E-07
0.20682110E-07 0.19716280E-07 0.18642260E-07 0.17468081E-07 0.16202279E-07
0.14853837E-07 0.13432120E-07 0.11946819E-07 0.10407883E-07 0.88254569E-08
0.72098151E-08 0.55712995E-08 0.39202539E-08 0.22669616E-08 0.62158331E-09
-0.10059033E-08 -0.26057620E-08 -0.41685539E-08 -0.56851915E-08 -0.71469892E-08
-0.85457109E-08 -0.98736147E-08 -0.11123493E-07 -0.12288710E-07 -0.13363235E-07
-0.14341670E-07 -0.15219275E-07 -0.15991988E-07 -0.16656443E-07 -0.17209977E-07
-0.17650642E-07 -0.17977205E-07 -0.18189145E-07 -0.18286649E-07 -0.18270603E-07
-0.18142574E-07 -0.17904792E-07 -0.17560132E-07 -0.17112083E-07 -0.16564722E-07
-0.15922679E-07 -0.15191107E-07 -0.14375635E-07 -0.13482335E-07 -0.12517678E-07
-0.11488487E-07 -0.10401891E-07 -0.92652805E-08 -0.80862565E-08 -0.68725824E-08
-0.56321344E-08 -0.43728519E-08 -0.31026886E-08 -0.18295637E-08 -0.56131359E-09
0.69435411E-09 0.19299065E-08 0.31380291E-08 0.43116674E-08 0.54440667E-08
0.65288098E-08 0.75598516E-08 0.85315512E-08 0.94387016E-08 0.10276556E-07
0.11040849E-07 0.11727821E-07 0.12334231E-07 0.12857370E-07 0.13295073E-07
0.13645724E-07 0.13908258E-07 0.14082165E-07 0.14167479E-07 0.14164779E-07
0.14075171E-07 0.13900282E-07 0.13642238E-07 0.13303647E-07 0.12887578E-07
0.12397536E-07 0.11837432E-07 0.11211561E-07 0.10524565E-07 0.97814013E-08
0.89873121E-08 0.81477851E-08 0.72685186E-08 0.63553840E-08 0.54143881E-08
0.44516340E-08 0.34732838E-08 0.24855193E-08 0.14945047E-08 0.50634894E-09
-0.47293086E-09 -0.14374450E-08 -0.23814654E-08 -0.32994588E-08 -0.41861182E-08
-0.50363921E-08 -0.58455128E-08 -0.66090213E-08 -0.73227917E-08 -0.79830514E-08
-0.85864005E-08 -0.91298279E-08 -0.96107249E-08 -0.10026896E-07 -0.10376569E-07
kinetic energy density (partial)
0.20835504E+03 0.20828036E+03 0.20805646E+03 0.20768382E+03 0.20716321E+03
0.20649571E+03 0.20568271E+03 0.20472590E+03 0.20362725E+03 0.20238902E+03
0.20101375E+03 0.19950424E+03 0.19786357E+03 0.19609504E+03 0.19420220E+03
0.19218884E+03 0.19005893E+03 0.18781665E+03 0.18546639E+03 0.18301267E+03
0.18046020E+03 0.17781381E+03 0.17507846E+03 0.17225923E+03 0.16936128E+03
0.16638985E+03 0.16335026E+03 0.16024787E+03 0.15708805E+03 0.15387623E+03
0.15061780E+03 0.14731817E+03 0.14398270E+03 0.14061674E+03 0.13722555E+03
0.13381436E+03 0.13038829E+03 0.12695239E+03 0.12351160E+03 0.12007077E+03
0.11663459E+03 0.11320766E+03 0.10979442E+03 0.10639916E+03 0.10302604E+03
0.99679032E+02 0.96361963E+02 0.93078483E+02 0.89832071E+02 0.86626025E+02
0.83463466E+02 0.80347331E+02 0.77280372E+02 0.74265159E+02 0.71304074E+02
0.68399315E+02 0.65552897E+02 0.62766650E+02 0.60042224E+02 0.57381093E+02
0.54784551E+02 0.52253723E+02 0.49789562E+02 0.47392858E+02 0.45064240E+02
0.42804181E+02 0.40613001E+02 0.38490877E+02 0.36437844E+02 0.34453799E+02
0.32538514E+02 0.30691635E+02 0.28912689E+02 0.27201094E+02 0.25556161E+02
0.23977101E+02 0.22463033E+02 0.21012989E+02 0.19625917E+02 0.18300694E+02
0.17036125E+02 0.15830955E+02 0.14683869E+02 0.13593503E+02 0.12558445E+02
0.11577245E+02 0.10648418E+02 0.97704471E+01 0.89417938E+01 0.81608982E+01
0.74261859E+01 0.67360722E+01 0.60889662E+01 0.54832751E+01 0.49174080E+01
0.43897800E+01 0.38988154E+01 0.34429512E+01 0.30206401E+01 0.26303538E+01
0.22705855E+01 0.19398523E+01 0.16366980E+01 0.13596948E+01 0.11074456E+01
0.87858565E+00 0.67178422E+00 0.48574594E+00 0.31921212E+00 0.17096183E+00
0.39812801E-01 -0.75377769E-01 -0.17571264E+00 -0.26225402E+00 -0.33602329E+00
-0.39800073E+00 -0.44912553E+00 -0.49029577E+00 -0.52236862E+00 -0.54616060E+00
-0.56244795E+00 -0.57196711E+00 -0.57541524E+00 -0.57345089E+00 -0.56669468E+00
-0.55573011E+00 -0.54110437E+00 -0.52332928E+00 -0.50288217E+00 -0.48020696E+00
-0.45571513E+00 -0.42978682E+00 -0.40277192E+00 -0.37499119E+00 -0.34673741E+00
-0.31827653E+00 -0.28984883E+00 -0.26167011E+00 -0.23393286E+00 -0.20680741E+00
-0.18044314E+00 -0.15496957E+00 -0.13049761E+00 -0.10712057E+00 -0.84915366E-01
-0.63943573E-01 -0.44252494E-01 -0.25876215E-01 -0.88366140E-02 0.68556445E-02
0.21200154E-01 0.34205840E-01 0.45890064E-01 0.56277765E-01 0.65400637E-01
0.73296336E-01 0.80007729E-01 0.85582175E-01 0.90070849E-01 0.93528093E-01
0.96010816E-01 0.97577916E-01 0.98289755E-01 0.98207654E-01 0.97393432E-01
0.95908984E-01 0.93815878E-01 0.91175003E-01 0.88046237E-01 0.84488154E-01
0.80557756E-01 0.76310236E-01 0.71798777E-01 0.67074366E-01 0.62185643E-01
0.57178774E-01 0.52097343E-01 0.46982274E-01 0.41871767E-01 0.36801261E-01
0.31803411E-01 0.26908081E-01 0.22142365E-01 0.17530606E-01 0.13094442E-01
0.88528613E-02 0.48222665E-02 0.10165515E-02 -0.25528120E-02 -0.58766813E-02
-0.89481411E-02 -0.11762397E-01 -0.14316661E-01 -0.16610039E-01 -0.18643408E-01
-0.20419294E-01 -0.21941748E-01 -0.23216224E-01 -0.24249453E-01 -0.25049318E-01
-0.25624730E-01 -0.25985512E-01 -0.26142277E-01 -0.26106309E-01 -0.25889459E-01
-0.25504030E-01 -0.24962671E-01 -0.24278285E-01 -0.23463926E-01 -0.22532710E-01
-0.21497732E-01 -0.20371987E-01 -0.19168289E-01 -0.17899208E-01 -0.16577007E-01
-0.15213577E-01 -0.13820394E-01 -0.12408464E-01 -0.10988288E-01 -0.95698218E-02
-0.81624485E-02 -0.67749510E-02 -0.54154923E-02 -0.40916000E-02 -0.28101553E-02
-0.15773864E-02 -0.39886651E-03 0.72048473E-03 0.17763955E-02 0.27652328E-02
0.36839902E-02 0.45302720E-02 0.53022756E-02 0.59987705E-02 0.66190753E-02
0.71630325E-02 0.76309821E-02 0.80237328E-02 0.83425325E-02 0.85890380E-02
0.87652830E-02 0.88736459E-02 0.89168179E-02 0.88977699E-02 0.88197199E-02
0.86861005E-02 0.85005271E-02 0.82667658E-02 0.79887032E-02 0.76703160E-02
0.73156421E-02 0.69287525E-02 0.65137246E-02 0.60746169E-02 0.56154446E-02
0.51401571E-02 0.46526166E-02 0.41565790E-02 0.36556751E-02 0.31533950E-02
0.26530725E-02 0.21578727E-02 0.16707797E-02 0.11945875E-02 0.73189104E-03
0.28508001E-03 -0.14366669E-03 -0.55238445E-03 -0.93932519E-03 -0.13029582E-02
-0.16419696E-02 -0.19552605E-02 -0.22419442E-02 -0.25013417E-02 -0.27329770E-02
-0.29365704E-02 -0.31120318E-02 -0.32594528E-02 -0.33790979E-02 -0.34713953E-02
-0.35369271E-02 -0.35764189E-02 -0.35907293E-02 -0.35808384E-02 -0.35478369E-02
-0.34929144E-02 -0.34173477E-02 -0.33224897E-02 -0.32097572E-02 -0.30806201E-02
-0.29365895E-02 -0.27792070E-02 -0.26100340E-02 -0.24306410E-02 -0.22425978E-02
-0.20474638E-02 -0.18467788E-02 -0.16420544E-02 -0.14347657E-02 -0.12263441E-02
-0.10181700E-02 -0.81156627E-03 -0.60779290E-03 -0.40804141E-03 -0.21343046E-03
-0.25001852E-04 0.15628276E-03 0.32954460E-03 0.49398988E-03 0.64891127E-03
0.79368888E-03 0.92779059E-03 0.10507719E-02 0.11622751E-02 0.12620285E-02
0.13498441E-02 0.14256161E-02 0.14893180E-02 0.15410000E-02 0.15807856E-02
0.16088679E-02 0.16255060E-02 0.16310209E-02 0.16257910E-02 0.16102478E-02
0.15848710E-02 0.15501843E-02 0.15067498E-02 0.14551636E-02 0.13960508E-02
0.13300607E-02 0.12578615E-02 0.11801361E-02 0.10975768E-02 0.10108810E-02
0.92074700E-03 0.82786904E-03 0.73293373E-03 0.63661585E-03 0.53957475E-03
0.44245079E-03 0.34586214E-03 0.25040173E-03 0.15663455E-03 0.65095164E-04
-0.23714500E-04 -0.10932708E-03 -0.19131143E-03 -0.26927401E-03 -0.34285994E-03
-0.41175391E-03 -0.47568067E-03 -0.53440538E-03 -0.58773362E-03 -0.63551122E-03
-0.67762383E-03 -0.71399622E-03 -0.74459146E-03 -0.76940981E-03 -0.78848749E-03
-0.80189519E-03 -0.80973655E-03 -0.81214635E-03 -0.80928869E-03 -0.80135496E-03
-0.78856182E-03 -0.77114897E-03 -0.74937696E-03 -0.72352489E-03 -0.69388808E-03
-0.66077574E-03 -0.62450863E-03 -0.58541671E-03 -0.54383679E-03 -0.50011029E-03
-0.45458098E-03 -0.40759277E-03 -0.35948764E-03 -0.31060361E-03 -0.26127274E-03
-0.21181934E-03 -0.16255822E-03 -0.11379303E-03 -0.65814813E-04 -0.18900553E-04
0.26688029E-04 0.70705622E-04 0.11292430E-03 0.15313440E-03 0.19114521E-03
0.22678554E-03 0.25990422E-03 0.29037033E-03 0.31807346E-03 0.34292368E-03
0.36485151E-03 0.38380771E-03 0.39976294E-03 0.41270738E-03 0.42265015E-03
0.42961871E-03 0.43365814E-03 0.43483030E-03 0.43321299E-03 0.42889897E-03
0.42199495E-03 0.41262052E-03 0.40090704E-03 0.38699647E-03 0.37104021E-03
0.35319789E-03 0.33363614E-03 0.31252735E-03 0.29004850E-03 0.26637987E-03
0.24170389E-03 0.21620396E-03 0.19006328E-03 0.16346372E-03 0.13658478E-03
0.10960256E-03 0.82688740E-04 0.56009692E-04 0.29725598E-04 0.39896497E-05
-0.21052691E-04 -0.45264363E-04 -0.68517308E-04 -0.90692998E-04 -0.11168289E-03
-0.13138883E-03 -0.14972332E-03 -0.16660980E-03 -0.18198279E-03 -0.19578798E-03
-0.20798226E-03 -0.21853367E-03 -0.22742128E-03 -0.23463504E-03 -0.24017552E-03
-0.24405359E-03 -0.24629014E-03 -0.24691561E-03 -0.24596960E-03 -0.24350031E-03
-0.23956409E-03 -0.23422482E-03 -0.22755332E-03 -0.21962678E-03 -0.21052803E-03
-0.20034496E-03 -0.18916981E-03 -0.17709849E-03 -0.16422991E-03 -0.15066529E-03
-0.13650745E-03 -0.12186019E-03 -0.10682758E-03 -0.91513375E-04 -0.76020313E-04
-0.60449570E-04 -0.44900164E-04 -0.29468403E-04 -0.14247369E-04 0.67356873E-06
0.15209201E-04 0.29278898E-04 0.42806978E-04 0.55723047E-04 0.67962294E-04
0.79465741E-04 0.90180456E-04 0.10005972E-03 0.10906317E-03 0.11715685E-03
0.12431330E-03 0.13051151E-03 0.13573694E-03 0.13998141E-03 0.14324297E-03
0.14552583E-03 0.14684010E-03 0.14720163E-03 0.14663173E-03 0.14515697E-03
0.14280879E-03 0.13962329E-03 0.13564081E-03 0.13090564E-03 0.12546560E-03
0.11937169E-03 0.11267772E-03 0.10543985E-03 0.97716257E-04 0.89566681E-04
0.81052046E-04 0.72234052E-04 0.63174778E-04 0.53936293E-04 0.44580280E-04
0.35167664E-04 0.25758258E-04 0.16410425E-04 0.71807582E-05 -0.18762292E-05
-0.10708382E-04 -0.19266170E-04 -0.27502926E-04 -0.35375063E-04 -0.42842270E-04
-0.49867681E-04 -0.56418019E-04 -0.62463713E-04 -0.67978995E-04 -0.72941966E-04
-0.77334643E-04 -0.81142972E-04 -0.84356829E-04 -0.86969986E-04 -0.88980058E-04
-0.90388434E-04 -0.91200176E-04 -0.91423905E-04 -0.91071668E-04 -0.90158782E-04
-0.88703670E-04 -0.86727673E-04 -0.84254855E-04 -0.81311794E-04 -0.77927359E-04
-0.74132487E-04 -0.69959941E-04 -0.65444073E-04 -0.60620576E-04 -0.55526235E-04
-0.50198677E-04 -0.44676123E-04 -0.38997144E-04 -0.33200410E-04 -0.27324458E-04
-0.21407454E-04 -0.15486974E-04 -0.95997806E-05 -0.37816209E-05 0.19329717E-05
0.75108618E-05 0.12920483E-04 0.18131998E-04 0.23117441E-04 0.27850849E-04
0.32308378E-04 0.36468400E-04 0.40311588E-04 0.43820986E-04 0.46982057E-04
0.49782725E-04 0.52213390E-04 0.54266937E-04 0.55938726E-04 0.57226565E-04
0.58130670E-04 0.58653618E-04 0.58800272E-04 0.58577711E-04 0.57995133E-04
0.57063756E-04 0.55796708E-04 0.54208903E-04 0.52316916E-04 0.50138843E-04
0.47694158E-04 0.45003568E-04 0.42088860E-04 0.38972742E-04 0.35678686E-04
0.32230771E-04 0.28653522E-04 0.24971746E-04 0.21210383E-04 0.17394344E-04
0.13548360E-04 0.96968386E-05 0.58637166E-05 0.20723263E-05 -0.16547360E-05
-0.52957328E-05 -0.88299004E-05 -0.12237557E-04 -0.15500199E-04 -0.18600592E-04
-0.21522849E-04 -0.24252503E-04 -0.26776561E-04 -0.29083560E-04 -0.31163602E-04
-0.33008383E-04 -0.34611214E-04 -0.35967028E-04 -0.37072379E-04 -0.37925428E-04
-0.38525927E-04 -0.38875183E-04 -0.38976024E-04 -0.38832747E-04 -0.38451068E-04
-0.37838051E-04 -0.37002046E-04 -0.35952608E-04 -0.34700415E-04 -0.33257184E-04
-0.31635572E-04 -0.29849087E-04 -0.27911987E-04 -0.25839175E-04 -0.23646098E-04
-0.21348641E-04 -0.18963022E-04 -0.16505685E-04 -0.13993199E-04 -0.11442146E-04
-0.88690290E-05 -0.62901661E-05 -0.37215965E-05 -0.11789878E-05 0.13224529E-05
0.37680632E-05 0.61438045E-05 0.84363361E-05 0.10633083E-04 0.12722299E-04
0.14693121E-04 0.16535621E-04 0.18240847E-04 0.19800862E-04 0.21208768E-04
0.22458735E-04 0.23546012E-04 0.24466937E-04 0.25218940E-04 0.25800535E-04
0.26211314E-04 0.26451924E-04 0.26524047E-04 0.26430366E-04 0.26174537E-04
0.25761142E-04 0.25195645E-04 0.24484347E-04 0.23634324E-04 0.22653376E-04
0.21549965E-04 0.20333146E-04 0.19012507E-04 0.17598097E-04 0.16100357E-04
0.14530050E-04 0.12898186E-04 0.11215955E-04 0.94946498E-05 0.77456005E-05
0.59801006E-05 0.42093402E-05 0.24443392E-05 0.69588305E-06 -0.10255391E-05
-0.27097932E-05 -0.43471557E-05 -0.59283657E-05 -0.74446735E-05 -0.88878846E-05
-0.10250400E-04 -0.11525252E-04 -0.12706136E-04 -0.13787435E-04 -0.14764247E-04
-0.15632395E-04 -0.16388446E-04 -0.17029714E-04 -0.17554268E-04 -0.17960926E-04
-0.18249251E-04 -0.18419541E-04 -0.18472814E-04 -0.18410788E-04 -0.18235860E-04
-0.17951076E-04 -0.17560106E-04 -0.17067207E-04 -0.16477189E-04 -0.15795372E-04
-0.15027551E-04 -0.14179945E-04 -0.13259159E-04 -0.12272129E-04 -0.11226083E-04
-0.10128482E-04 -0.89869785E-05 -0.78093612E-05 -0.66035078E-05 -0.53773340E-05
-0.41387451E-05 -0.28955872E-05 -0.16556008E-05 -0.42637512E-06 0.78469609E-06
0.19704560E-05 0.31240246E-05 0.42388361E-05 0.53086738E-05 0.63277021E-05
0.72904958E-05 0.81920664E-05 0.90278850E-05 0.97939027E-05 0.10486567E-04
0.11102835E-04 0.11640184E-04 0.12096617E-04 0.12470670E-04 0.12761405E-04
0.12968414E-04 0.13091808E-04 0.13132211E-04 0.13090746E-04 0.12969018E-04
0.12769101E-04 0.12493512E-04 0.12145193E-04 0.11727484E-04 0.11244095E-04
0.10699079E-04 0.10096800E-04 0.94419040E-05 0.87392820E-05 0.79940391E-05
0.72114589E-05 0.63969681E-05 0.55561008E-05 0.46944635E-05 0.38176993E-05
0.29314527E-05 0.20413352E-05 0.11528915E-05 0.27156677E-06 -0.59732538E-06
-0.14486329E-05 -0.22773945E-05 -0.30788666E-05 -0.38485492E-05 -0.45822095E-05
-0.52759030E-05 -0.59259938E-05 -0.65291711E-05 -0.70824650E-05 -0.75832587E-05
-0.80292992E-05 -0.84187053E-05 -0.87499729E-05 -0.90219787E-05 -0.92339806E-05
-0.93856165E-05 -0.94769006E-05 -0.95082170E-05 -0.94803119E-05 -0.93942833E-05
-0.92515686E-05 -0.90539305E-05 -0.88034415E-05 -0.85024659E-05 -0.81536409E-05
-0.77598566E-05 -0.73242339E-05 -0.68501020E-05 -0.63409749E-05 -0.58005271E-05
-0.52325683E-05 -0.46410183E-05 -0.40298813E-05 -0.34032201E-05 -0.27651301E-05
-0.21197141E-05 -0.14710570E-05 -0.82320100E-06 -0.18012145E-06 0.45429620E-06
0.10762789E-05 0.16821875E-05 0.22685368E-05 0.28320144E-05 0.33694988E-05
0.38780750E-05 0.43550498E-05 0.47979643E-05 0.52046059E-05 0.55730178E-05
0.59015075E-05 0.61886525E-05 0.64333056E-05 0.66345974E-05 0.67919376E-05
0.69050145E-05 0.69737925E-05 0.69985083E-05 0.69796653E-05 0.69180270E-05
0.68146078E-05 0.66706633E-05 0.64876794E-05 0.62673592E-05 0.60116097E-05
0.57225273E-05 0.54023816E-05 0.50535996E-05 0.46787481E-05 0.42805159E-05
0.38616961E-05 0.34251668E-05 0.29738728E-05 0.25108063E-05 0.20389878E-05
0.15614475E-05 0.10812068E-05 0.60125910E-06 0.12455292E-06 -0.34602614E-06
-0.80767194E-06 -0.12576738E-05 -0.16934316E-05 -0.21124705E-05 -0.25124536E-05
-0.28911947E-05 -0.32466697E-05 -0.35770259E-05 -0.38805915E-05 -0.41558832E-05
-0.44016122E-05 -0.46166896E-05 -0.48002299E-05 -0.49515539E-05 -0.50701897E-05
-0.51558725E-05 -0.52085437E-05 -0.52283475E-05 -0.52156282E-05 -0.51709243E-05
-0.50949632E-05 -0.49886534E-05 -0.48530769E-05 -0.46894800E-05 -0.44992632E-05
-0.42839704E-05 -0.40452779E-05 -0.37849817E-05 -0.35049853E-05 -0.32072862E-05
-0.28939625E-05 -0.25671593E-05 -0.22290742E-05 -0.18819433E-05 -0.15280272E-05
-0.11695966E-05 -0.80891805E-06 -0.44824079E-06 -0.89782651E-07 0.26428284E-06
0.61183918E-06 0.95083906E-06 0.12793159E-05 0.15953948E-05 0.18973026E-05
0.21833778E-05 0.24520784E-05 0.27019904E-05 0.29318344E-05 0.31404715E-05
0.33269085E-05 0.34903020E-05 0.36299613E-05 0.37453508E-05 0.38360910E-05
0.39019586E-05 0.39428861E-05 0.39589597E-05 0.39504170E-05 0.39176432E-05
0.38611669E-05 0.37816552E-05 0.36799070E-05 0.35568472E-05 0.34135188E-05
0.32510750E-05 0.30707708E-05 0.28739539E-05 0.26620552E-05 0.24365789E-05
0.21990924E-05 0.19512158E-05 0.16946112E-05 0.14309721E-05 0.11620127E-05
0.88945703E-06 0.61502809E-06 0.34043765E-06 0.67375715E-07 -0.20249943E-06
-0.46757098E-06 -0.72627297E-06 -0.97709914E-06 -0.12186114E-05 -0.14494477E-05
-0.16683294E-05 -0.18740679E-05 -0.20655709E-05 -0.22418477E-05 -0.24020138E-05
-0.25452953E-05 -0.26710317E-05 -0.27786789E-05 -0.28678107E-05 -0.29381202E-05
-0.29894195E-05 -0.30216403E-05 -0.30348315E-05 -0.30291587E-05 -0.30049005E-05
-0.29624463E-05 -0.29022916E-05 -0.28250345E-05 -0.27313699E-05 -0.26220845E-05
-0.24980506E-05 -0.23602199E-05 -0.22096162E-05 -0.20473288E-05 -0.18745043E-05
-0.16923396E-05 -0.15020733E-05 -0.13049781E-05 -0.11023521E-05 -0.89551080E-06
-0.68577898E-06 -0.47448212E-06 -0.26293851E-06 -0.52451208E-07 0.15569972E-06
0.36026474E-06 0.56003214E-06 0.75383492E-06 0.94055739E-06 0.11191414E-05
0.12885918E-05 0.14479824E-05 0.15964599E-05 0.17332489E-05 0.18576553E-05
0.19690697E-05 0.20669698E-05 0.21509228E-05 0.22205870E-05 0.22757124E-05
0.23161411E-05 0.23418077E-05 0.23527377E-05 0.23490468E-05 0.23309391E-05
0.22987043E-05 0.22527152E-05 0.21934244E-05 0.21213603E-05 0.20371233E-05
0.19413808E-05 0.18348627E-05 0.17183559E-05 0.15926988E-05 0.14587758E-05
0.13175109E-05 0.11698619E-05 0.10168141E-05 0.85937351E-06 0.69856113E-06
0.53540601E-06 0.37093900E-06 0.20618646E-06 0.42164007E-07 -0.12012960E-06
-0.27971831E-06 -0.43565451E-06 -0.58702449E-06 -0.73295359E-06 -0.87261108E-06
-0.10052148E-05 -0.11300351E-05 -0.12463990E-05 -0.13536936E-05 -0.14513687E-05
-0.15389398E-05 -0.16159903E-05 -0.16821729E-05 -0.17372113E-05 -0.17809007E-05
atomic pseudo charge-density
0.40000000E+01 0.39865777E+01 0.39466377E+01 0.38811433E+01 0.37916420E+01
0.36801845E+01 0.35492225E+01 0.34014950E+01 0.32399100E+01 0.30674335E+01
0.28869885E+01 0.27013712E+01 0.25131849E+01 0.23247937E+01 0.21382919E+01
0.19554911E+01 0.17779180E+01 0.16068237E+01 0.14431992E+01 0.12877965E+01
0.11411517E+01 0.10036103E+01 0.87535141E+00 0.75641221E+00 0.64671002E+00
0.54606322E+00 0.45420995E+00 0.37082491E+00 0.29553413E+00 0.22792794E+00
0.16757211E+00 0.11401745E+00 0.66807917E-01 0.25487413E-01 -0.10394609E-01
-0.41278559E-01 -0.67591068E-01 -0.89742136E-01 -0.10812299E+00 -0.12310456E+00
-0.13503646E+00 -0.14424639E+00 -0.15104001E+00 -0.15570097E+00 -0.15849133E+00
-0.15965211E+00 -0.15940402E+00 -0.15794831E+00 -0.15546772E+00 -0.15212749E+00
-0.14807638E+00 -0.14344771E+00 -0.13836047E+00 -0.13292033E+00 -0.12722065E+00
-0.12134348E+00 -0.11536052E+00 -0.10933401E+00 -0.10331755E+00 -0.97357004E-01
-0.91491144E-01 -0.85752437E-01 -0.80167665E-01 -0.74758549E-01 -0.69542301E-01
-0.64532148E-01 -0.59737800E-01 -0.55165888E-01 -0.50820352E-01 -0.46702805E-01
-0.42812853E-01 -0.39148390E-01 -0.35705857E-01 -0.32480485E-01 -0.29466501E-01
-0.26657315E-01 -0.24045694E-01 -0.21623903E-01 -0.19383840E-01 -0.17317147E-01
-0.15415312E-01 -0.13669755E-01 -0.12071903E-01 -0.10613251E-01 -0.92854244E-02
-0.80802145E-02 -0.69896237E-02 -0.60058937E-02 -0.51215308E-02 -0.43293255E-02
-0.36223668E-02 -0.29940530E-02 -0.24380979E-02 -0.19485345E-02 -0.15197156E-02
-0.11463116E-02 -0.82330733E-03 -0.54599558E-03 -0.30997057E-03 -0.11111936E-03
0.54387372E-04 0.19010550E-03 0.29932812E-03 0.38509675E-03 0.45021276E-03
0.49724905E-03 0.52856181E-03 0.54630218E-03 0.55242796E-03 0.54871497E-03
0.53676838E-03 0.51803363E-03 0.49380709E-03 0.46524638E-03 0.43338033E-03
0.39911848E-03 0.36326026E-03 0.32650372E-03 0.28945381E-03 0.25263029E-03
0.21647518E-03 0.18135979E-03 0.14759134E-03 0.11541921E-03 0.85040745E-04
0.56606693E-04 0.30226281E-04 0.59719222E-05 -0.16116422E-04 -0.36027206E-04
-0.53773582E-04 -0.69389985E-04 -0.82929001E-04 -0.94458506E-04 -0.10405906E-03
-0.11182154E-03 -0.11784501E-03 -0.12223480E-03 -0.12510074E-03 -0.12655568E-03
-0.12671406E-03 -0.12569075E-03 -0.12359995E-03 -0.12055428E-03 -0.11666396E-03
-0.11203618E-03 -0.10677445E-03 -0.10097817E-03 -0.94742200E-04 -0.88156578E-04
-0.81306252E-04 -0.74270913E-04 -0.67124872E-04 -0.59936998E-04 -0.52770692E-04
-0.45683909E-04 -0.38729216E-04 -0.31953881E-04 -0.25399987E-04 -0.19104573E-04
-0.13099795E-04 -0.74131035E-05 -0.20674340E-05 0.29185877E-05 0.75304328E-05
0.11757450E-04 0.15592638E-04 0.19032418E-04 0.22076404E-04 0.24727164E-04
0.26989996E-04 0.28872695E-04 0.30385326E-04 0.31539999E-04 0.32350652E-04
0.32832837E-04 0.33003507E-04 0.32880817E-04 0.32483927E-04 0.31832814E-04
0.30948087E-04 0.29850816E-04 0.28562367E-04 0.27104239E-04 0.25497920E-04
0.23764744E-04 0.21925760E-04 0.20001608E-04 0.18012403E-04 0.15977634E-04
0.13916067E-04 0.11845655E-04 0.97834623E-05 0.77455969E-05 0.57471478E-05
0.38021359E-05 0.19234706E-05 0.12291697E-06 -0.15889304E-05 -0.32026639E-05
-0.47100721E-05 -0.61041411E-05 -0.73790486E-05 -0.85301498E-05 -0.95539581E-05
-0.10448118E-04 -0.11211371E-04 -0.11843520E-04 -0.12345381E-04 -0.12718740E-04
-0.12966293E-04 -0.13091593E-04 -0.13098990E-04 -0.12993562E-04 -0.12781054E-04
-0.12467805E-04 -0.12060682E-04 -0.11567004E-04 -0.10994473E-04 -0.10351102E-04
-0.96451441E-05 -0.88850170E-05 -0.80792383E-05 -0.72363555E-05 -0.63648798E-05
-0.54732233E-05 -0.45696380E-05 -0.36621584E-05 -0.27585476E-05 -0.18662470E-05
-0.99232994E-06 -0.14345991E-06 0.67414724E-06 0.14547563E-05 0.21931413E-05
0.28846089E-05 0.35250176E-05 0.41107917E-05 0.46389308E-05 0.51070144E-05
0.55132020E-05 0.58562288E-05 0.61353970E-05 0.63505627E-05 0.65021194E-05
0.65909775E-05 0.66185401E-05 0.65866761E-05 0.64976905E-05 0.63542912E-05
0.61595549E-05 0.59168901E-05 0.56299985E-05 0.53028363E-05 0.49395727E-05
0.45445501E-05 0.41222417E-05 0.36772115E-05 0.32140730E-05 0.27374494E-05
0.22519349E-05 0.17620572E-05 0.12722412E-05 0.78677566E-06 0.30978034E-06
-0.15482310E-06 -0.60333860E-06 -0.10323203E-05 -0.14385946E-05 -0.18192788E-05
-0.21717975E-05 -0.24938958E-05 -0.27836489E-05 -0.30394696E-05 -0.32601119E-05
-0.34446725E-05 -0.35925882E-05 -0.37036321E-05 -0.37779053E-05 -0.38158276E-05
-0.38181247E-05 -0.37858135E-05 -0.37201857E-05 -0.36227886E-05 -0.34954051E-05
-0.33400317E-05 -0.31588555E-05 -0.29542301E-05 -0.27286505E-05 -0.24847277E-05
-0.22251630E-05 -0.19527218E-05 -0.16702079E-05 -0.13804382E-05 -0.10862172E-05
-0.79031329E-06 -0.49543528E-06 -0.20421011E-06 0.80837975E-07 0.35730694E-06
0.62293496E-06 0.87561665E-06 0.11134176E-05 0.13345872E-05 0.15375689E-05
0.17210098E-05 0.18837666E-05 0.20249111E-05 0.21437323E-05 0.22397380E-05
0.23126529E-05 0.23624163E-05 0.23891767E-05 0.23932857E-05 0.23752896E-05
0.23359196E-05 0.22760813E-05 0.21968416E-05 0.20994157E-05 0.19851524E-05
0.18555189E-05 0.17120850E-05 0.15565060E-05 0.13905063E-05 0.12158623E-05
0.10343849E-05 0.84790272E-06 0.65824498E-06 0.46722542E-06 0.27662610E-06
0.88182235E-07 -0.96432316E-07 -0.27561869E-06 -0.44786563E-06 -0.61176105E-06
-0.76600248E-06 -0.90940617E-06 -0.10409151E-05 -0.11596055E-05 -0.12646923E-05
-0.13555325E-05 -0.14316286E-05 -0.14926287E-05 -0.15383273E-05 -0.15686631E-05
-0.15837168E-05 -0.15837066E-05 -0.15689836E-05 -0.15400253E-05 -0.14974285E-05
-0.14419012E-05 -0.13742537E-05 -0.12953888E-05 -0.12062916E-05 -0.11080189E-05
-0.10016876E-05 -0.88846338E-06 -0.76954920E-06 -0.64617321E-06 -0.51957713E-06
-0.39100463E-06 -0.26168993E-06 -0.13284673E-06 -0.56575985E-08 0.11873617E-06
0.23924409E-06 0.35483532E-06 0.46454683E-06 0.56749076E-06 0.66286088E-06
0.74993828E-06 0.82809602E-06 0.89680296E-06 0.95562658E-06 0.10042348E-05
0.10423970E-05 0.10699838E-05 0.10869664E-05 0.10934144E-05 0.10894933E-05
0.10754611E-05 0.10516635E-05 0.10185295E-05 0.97656513E-06 0.92634782E-06
0.86851908E-06 0.80377754E-06 0.73287127E-06 0.65658987E-06 0.57575636E-06
0.49121891E-06 0.40384252E-06 0.31450065E-06 0.22406708E-06 0.13340778E-06
0.43373085E-07 -0.45209802E-07 -0.13154400E-06 -0.21486970E-06 -0.29447041E-06
-0.36967874E-06 -0.43988155E-06 -0.50452456E-06 -0.56311628E-06 -0.61523130E-06
-0.66051294E-06 -0.69867516E-06 -0.72950384E-06 -0.75285729E-06 -0.76866619E-06
-0.77693279E-06 -0.77772948E-06 -0.77119677E-06 -0.75754063E-06 -0.73702932E-06
-0.70998970E-06 -0.67680308E-06 -0.63790058E-06 -0.59375822E-06 -0.54489163E-06
-0.49185048E-06 -0.43521276E-06 -0.37557887E-06 -0.31356558E-06 -0.24980003E-06
-0.18491372E-06 -0.11953651E-06 -0.54290839E-07 0.10213919E-07 0.73386891E-07
0.13466084E-06 0.19349698E-06 0.24938949E-06 0.30186957E-06 0.35050912E-06
0.39492396E-06 0.43477660E-06 0.46977849E-06 0.49969185E-06 0.52433087E-06
0.54356256E-06 0.55730693E-06 0.56553685E-06 0.56827727E-06 0.56560403E-06
0.55764226E-06 0.54456431E-06 0.52658722E-06 0.50396998E-06 0.47701026E-06
0.44604100E-06 0.41142663E-06 0.37355910E-06 0.33285375E-06 0.28974500E-06
0.24468193E-06 0.19812388E-06 0.15053591E-06 0.10238442E-06 0.54132716E-07
0.62367788E-08 -0.40858886E-07 -0.86725192E-07 -0.13095221E-06 -0.17315265E-06
-0.21296511E-06 -0.25005694E-06 -0.28412693E-06 -0.31490750E-06 -0.34216665E-06
-0.36570951E-06 -0.38537949E-06 -0.40105911E-06 -0.41267040E-06 -0.42017495E-06
-0.42357360E-06 -0.42290573E-06 -0.41824822E-06 -0.40971413E-06 -0.39745100E-06
-0.38163883E-06 -0.36248792E-06 -0.34023633E-06 -0.31514719E-06 -0.28750579E-06
-0.25761658E-06 -0.22579994E-06 -0.19238893E-06 -0.15772595E-06 -0.12215937E-06
-0.86040187E-07 -0.49718647E-07 -0.13541005E-07 0.22153667E-07 0.57036538E-07
0.90791928E-07 0.12312006E-06 0.15373959E-06 0.18238997E-06 0.20883351E-06
0.23285726E-06 0.25427458E-06 0.27292648E-06 0.28868261E-06 0.30144207E-06
0.31113384E-06 0.31771695E-06 0.32118039E-06 0.32154272E-06 0.31885140E-06
0.31318189E-06 0.30463646E-06 0.29334283E-06 0.27945252E-06 0.26313906E-06
0.24459602E-06 0.22403482E-06 0.20168251E-06 0.17777935E-06 0.15257633E-06
0.12633270E-06 0.99313318E-07 0.71786140E-07 0.44019613E-07 0.16280158E-07
-0.11170310E-07 -0.38076764E-07 -0.64193365E-07 -0.89285620E-07 -0.11313241E-06
-0.13552787E-06 -0.15628307E-06 -0.17522752E-06 -0.19221052E-06 -0.20710224E-06
-0.21979462E-06 -0.23020204E-06 -0.23826179E-06 -0.24393430E-06 -0.24720317E-06
-0.24807490E-06 -0.24657857E-06 -0.24276514E-06 -0.23670665E-06 -0.22849526E-06
-0.21824199E-06 -0.20607547E-06 -0.19214040E-06 -0.17659596E-06 -0.15961408E-06
-0.14137764E-06 -0.12207857E-06 -0.10191591E-06 -0.81093788E-07 -0.59819486E-07
-0.38301386E-07 -0.16747007E-07 0.46389382E-08 0.25656431E-07 0.46111962E-07
0.65820256E-07 0.84605894E-07 0.10230482E-06 0.11876572E-06 0.13385124E-06
0.14743910E-06 0.15942300E-06 0.16971338E-06 0.17823805E-06 0.18494256E-06
0.18979049E-06 0.19276351E-06 0.19386128E-06 0.19310120E-06 0.19051798E-06
0.18616304E-06 0.18010382E-06 0.17242285E-06 0.16321682E-06 0.15259538E-06
0.14067999E-06 0.12760255E-06 0.11350404E-06 0.98533033E-07 0.82844184E-07
0.66596694E-07 0.49952735E-07 0.33075874E-07 0.16129513E-07 -0.72465324E-09
-0.17328139E-07 -0.33527119E-07 -0.49173812E-07 -0.64127789E-07 -0.78257197E-07
-0.91439880E-07 -0.10356439E-06 -0.11453090E-06 -0.12425196E-06 -0.13265316E-06
-0.13967366E-06 -0.14526653E-06 -0.14939904E-06 -0.15205274E-06 -0.15322347E-06
-0.15292112E-06 -0.15116943E-06 -0.14800550E-06 -0.14347929E-06 -0.13765294E-06
-0.13060004E-06 -0.12240475E-06 -0.11316085E-06 -0.10297075E-06 -0.91944386E-07
-0.80198063E-07 -0.67853283E-07 -0.55035515E-07 -0.41872961E-07 -0.28495302E-07
-0.15032454E-07 -0.16133352E-08 0.11635336E-07 0.24590209E-07 0.37132420E-07
0.49148656E-07 0.60532143E-07 0.71183572E-07 0.81011928E-07 0.89935244E-07
0.97881244E-07 0.10478790E-06 0.11060388E-06 0.11528886E-06 0.11881382E-06
0.12116109E-06 0.12232439E-06 0.12230878E-06 0.12113038E-06 0.11881613E-06
0.11540336E-06 0.11093929E-06 0.10548050E-06 0.99092190E-07 0.91847517E-07
0.83826762E-07 0.75116481E-07 0.65808606E-07 0.55999498E-07 0.45788981E-07
0.35279347E-07 0.24574360E-07 0.13778250E-07 0.29947206E-08 -0.76740207E-08
-0.18128214E-07 -0.28271459E-07 -0.38011579E-07 -0.47261440E-07 -0.55939707E-07
-0.63971541E-07 -0.71289215E-07 -0.77832665E-07 -0.83549956E-07 -0.88397669E-07
-0.92341195E-07 -0.95354951E-07 -0.97422500E-07 -0.98536589E-07 -0.98699097E-07
-0.97920896E-07 -0.96221633E-07 -0.93629426E-07 -0.90180493E-07 -0.85918699E-07
-0.80895042E-07 -0.75167082E-07 -0.68798307E-07 -0.61857456E-07 -0.54417806E-07
-0.46556413E-07 -0.38353339E-07 -0.29890854E-07 -0.21252631E-07 -0.12522934E-07
-0.37858156E-08 0.48756775E-08 0.13380276E-07 0.21649236E-07 0.29607050E-07
0.37182121E-07 0.44307392E-07 0.50920920E-07 0.56966402E-07 0.62393631E-07
0.67158897E-07 0.71225322E-07 0.74563117E-07 0.77149777E-07 0.78970206E-07
0.80016760E-07 0.80289232E-07 0.79794755E-07 0.78547650E-07 0.76569190E-07
0.73887320E-07 0.70536305E-07 0.66556328E-07 0.61993032E-07 0.56897024E-07
0.51323331E-07 0.45330824E-07 0.38981613E-07 0.32340417E-07 0.25473921E-07
0.18450117E-07 0.11337647E-07 0.42051412E-08 -0.28794280E-08 -0.98493841E-08
-0.16639961E-07 -0.23188892E-07 -0.29436970E-07 -0.35328568E-07 -0.40812125E-07
-0.45840579E-07 -0.50371762E-07 -0.54368736E-07 -0.57800081E-07 -0.60640121E-07
-0.62869100E-07 -0.64473297E-07 -0.65445078E-07 -0.65782899E-07 -0.65491242E-07
-0.64580506E-07 -0.63066827E-07 -0.60971865E-07 -0.58322529E-07 -0.55150654E-07
-0.51492651E-07 -0.47389095E-07 -0.42884300E-07 -0.38025850E-07 -0.32864112E-07
-0.27451723E-07 -0.21843067E-07 -0.16093737E-07 -0.10259996E-07 -0.43982344E-08
0.14355627E-08 0.71863441E-08 0.12800501E-07 0.18226358E-07 0.23414641E-07
0.28318911E-07 0.32895976E-07 0.37106258E-07 0.40914127E-07 0.44288191E-07
0.47201541E-07 0.49631959E-07 0.51562064E-07 0.52979429E-07 0.53876634E-07
0.54251276E-07 0.54105940E-07 0.53448106E-07 0.52290030E-07 0.50648562E-07
0.48544941E-07 0.46004535E-07 0.43056558E-07 0.39733743E-07 0.36071996E-07
0.32110014E-07 0.27888888E-07 0.23451687E-07 0.18843027E-07 0.14108626E-07
0.92948675E-08 0.44483443E-08 -0.38457840E-09 -0.51582018E-08 -0.98279172E-08
-0.14350616E-07 -0.18685080E-07 -0.22792350E-07 -0.26636066E-07 -0.30182785E-07
-0.33402261E-07 -0.36267695E-07 -0.38755949E-07 -0.40847725E-07 -0.42527701E-07
-0.43784631E-07 -0.44611406E-07 -0.45005075E-07 -0.44966822E-07 -0.44501911E-07
-0.43619591E-07 -0.42332959E-07 -0.40658796E-07 -0.38617367E-07 -0.36232185E-07
-0.33529757E-07 -0.30539298E-07 -0.27292420E-07 -0.23822813E-07 -0.20165895E-07
-0.16358462E-07 -0.12438321E-07 -0.84439245E-08 -0.44139948E-08 -0.38715706E-09
0.35984264E-08 0.75054122E-08 0.11297620E-07 0.14940364E-07 0.18400759E-07
0.21648020E-07 0.24653721E-07 0.27392046E-07 0.29839999E-07 0.31977589E-07
0.33787991E-07 0.35257666E-07 0.36376450E-07 0.37137619E-07 0.37537909E-07
0.37577509E-07 0.37260025E-07 0.36592399E-07 0.35584817E-07 0.34250568E-07
0.32605889E-07 0.30669776E-07 0.28463775E-07 0.26011753E-07 0.23339640E-07
0.20475168E-07 0.17447585E-07 0.14287364E-07 0.11025901E-07 0.76952074E-08
0.43276014E-08 0.95539922E-09 -0.23893908E-08 -0.56753669E-08 -0.88720247E-08
-0.11950035E-07 -0.14881510E-07 -0.17640250E-07 -0.20201972E-07 -0.22544524E-07
-0.24648063E-07 -0.26495225E-07 -0.28071260E-07 -0.29364144E-07 -0.30364661E-07
-0.31066465E-07 -0.31466104E-07 -0.31563026E-07 -0.31359549E-07 -0.30860813E-07
-0.30074696E-07 -0.29011715E-07 -0.27684894E-07 -0.26109618E-07 -0.24303457E-07
-0.22285982E-07 -0.20078552E-07 -0.17704100E-07 -0.15186893E-07 -0.12552291E-07
-0.98264954E-08 -0.70362916E-08 -0.42087888E-08 -0.13711612E-08 0.14496101E-08
0.42269901E-08 0.69351355E-08 0.95491319E-08 0.12045220E-07 0.14401006E-07
0.16595662E-07 0.18610102E-07 0.20427146E-07 0.22031661E-07 0.23410684E-07
0.24553519E-07 0.25451815E-07 0.26099624E-07 0.26493423E-07 0.26632132E-07
0.26517089E-07 0.26152020E-07 0.25542974E-07 0.24698245E-07 0.23628266E-07
0.22345494E-07 0.20864267E-07 0.19200649E-07 0.17372264E-07 0.15398111E-07
0.13298372E-07 0.11094206E-07 0.88075432E-08 0.64608682E-08 0.40770010E-08
0.16788790E-08 -0.71066103E-09 -0.30690973E-08 -0.53744330E-08 -0.76053985E-08
-0.97416452E-08 -0.11763929E-07 -0.13654278E-07 -0.15396156E-07 -0.16974594E-07
-0.18376325E-07 -0.19589886E-07 -0.20605711E-07 -0.21416199E-07 -0.22015771E-07
-0.22400896E-07 -0.22570106E-07 -0.22523988E-07 -0.22265159E-07 -0.21798218E-07
-0.21129684E-07 -0.20267914E-07 -0.19223007E-07 -0.18006686E-07 -0.16632178E-07
-0.15114066E-07 -0.13468142E-07 -0.11711246E-07 -0.98610957E-08 -0.79361089E-08
-0.59552253E-08 -0.39377210E-08 -0.19030235E-08 0.12947253E-09 0.21405877E-08
0.41115363E-08 0.60240990E-08 0.78607894E-08 0.96050108E-08 0.11241205E-07
0.12754986E-07 0.14133267E-07 0.15364369E-07 0.16438116E-07 0.17345916E-07
0.18080829E-07 0.18637614E-07 0.19012761E-07 0.19204509E-07 0.19212846E-07
0.19039488E-07 0.18687849E-07 0.18162994E-07 0.17471570E-07 0.16621732E-07
0.15623051E-07 0.14486408E-07 0.13223881E-07 0.11848618E-07 0.10374701E-07
0.88170072E-08 0.71910591E-08 0.55128719E-08 0.37987983E-08 0.20653706E-08
0.32914233E-09 -0.13934677E-08 -0.30863295E-08 -0.47337509E-08 -0.63206208E-08
-0.78325462E-08 -0.92559808E-08 -0.10578344E-07 -0.11788132E-07 -0.12875014E-07
-0.13829917E-07 -0.14645103E-07 -0.15314224E-07 -0.15832370E-07 -0.16196103E-07
-0.16403471E-07 -0.16454014E-07 -0.16348755E-07 -0.16090177E-07 -0.15682179E-07
-0.15130034E-07 -0.14440317E-07 -0.13620840E-07 -0.12680557E-07 -0.11629478E-07
19.8421228800787 T
Non local Part
0 2 1.03170241276447
8.48191517218165 11.7757836767903 11.7757836767903
16.3515625171536
Reciprocal Space Part
0.59618802E+02 0.58728804E+02 0.56074024E+02 0.51699804E+02 0.45680746E+02
0.38119274E+02 0.29143671E+02 0.18905623E+02 0.75773282E+01 -0.46517683E+01
-0.17578547E+02 -0.30990019E+02 -0.44667277E+02 -0.58389527E+02 -0.71938095E+02
-0.85100345E+02 -0.97673425E+02 -0.10946776E+03 -0.12031025E+03 -0.13004704E+03
-0.13854596E+03 -0.14569837E+03 -0.15142064E+03 -0.15565502E+03 -0.15837002E+03
-0.15956027E+03 -0.15924591E+03 -0.15747139E+03 -0.15430398E+03 -0.14983176E+03
-0.14416132E+03 -0.13741514E+03 -0.12972880E+03 -0.12124795E+03 -0.11212524E+03
-0.10251722E+03 -0.92581277E+02 -0.82472653E+02 -0.72341667E+02 -0.62331121E+02
-0.52573985E+02 -0.43191382E+02 -0.34290898E+02 -0.25965259E+02 -0.18291368E+02
-0.11329718E+02 -0.51241765E+01 0.29787571E+00 0.49250688E+01 0.87612564E+01
0.11824451E+02 0.14145521E+02 0.15766686E+02 0.16739863E+02 0.17124899E+02
0.16987748E+02 0.16398621E+02 0.15430172E+02 0.14155746E+02 0.12647730E+02
0.10976046E+02 0.92067952E+01 0.74011008E+01 0.56141435E+01 0.38944113E+01
0.22831646E+01 0.81411644E+00 -0.48667978E+00 -0.16007453E+01 -0.25169103E+01
-0.32308862E+01 -0.37446987E+01 -0.40660062E+01 -0.42073286E+01 -0.41852143E+01
-0.40193711E+01 -0.37317875E+01 -0.33458677E+01 -0.28856034E+01 -0.23748024E+01
-0.18363896E+01 -0.12917960E+01 -0.76044515E+00 -0.25934295E+00 0.19722322E+00
0.59787806E+00 0.93424642E+00 0.12009418E+01 0.13954638E+01 0.15180138E+01
0.15712429E+01 0.15599426E+01 0.14906942E+01 0.13714899E+01 0.12113407E+01
0.10198828E+01 0.80699697E+00 0.58245003E+00 0.35557023E+00 0.13496271E+00
Real Space Part
-0.87257185E+03 -0.87217325E+03 -0.87097758E+03 -0.86898535E+03 -0.86619740E+03
-0.86261493E+03 -0.85823952E+03 -0.85307319E+03 -0.84711839E+03 -0.84037811E+03
-0.83285587E+03 -0.82455582E+03 -0.81548281E+03 -0.80564241E+03 -0.79504105E+03
-0.78368604E+03 -0.77158570E+03 -0.75874942E+03 -0.74518776E+03 -0.73091251E+03
-0.71593685E+03 -0.70027535E+03 -0.68394415E+03 -0.66696100E+03 -0.64934533E+03
-0.63111840E+03 -0.61230331E+03 -0.59292512E+03 -0.57301089E+03 -0.55258976E+03
-0.53169298E+03 -0.51035396E+03 -0.48860832E+03 -0.46649386E+03 -0.44405060E+03
-0.42132076E+03 -0.39834870E+03 -0.37518093E+03 -0.35186599E+03 -0.32845440E+03
-0.30499855E+03 -0.28155254E+03 -0.25817210E+03 -0.23491433E+03 -0.21183758E+03
-0.18900121E+03 -0.16646531E+03 -0.14429049E+03 -0.12253758E+03 -0.10126731E+03
-0.80539962E+02 -0.60415079E+02 -0.40951054E+02 -0.22204768E+02 -0.42311995E+01
0.12916980E+02 0.29189809E+02 0.44540445E+02 0.58925573E+02 0.72305804E+02
0.84646067E+02 0.95915987E+02 0.10609024E+03 0.11514887E+03 0.12307763E+03
0.12986821E+03 0.13551849E+03 0.14003271E+03 0.14342163E+03 0.14570263E+03
0.14689971E+03 0.14704353E+03 0.14617130E+03 0.14432667E+03 0.14155957E+03
0.13792593E+03 0.13348743E+03 0.12831116E+03 0.12246922E+03 0.11603831E+03
0.10909924E+03 0.10173648E+03 0.94037578E+02 0.86092680E+02 0.77993902E+02
0.69834817E+02 0.61709839E+02 0.53713688E+02 0.45940793E+02 0.38484762E+02
0.31437841E+02 0.24890391E+02 0.18930406E+02 0.13643042E+02 0.91101706E+01
0.54100403E+01 0.26168332E+01 0.79835325E+00 0.23427012E-01 0.00000000E+00
Reciprocal Space Part
-0.36489549E+02 -0.35864156E+02 -0.33998755E+02 -0.30925471E+02 -0.26697153E+02
-0.21386360E+02 -0.15083959E+02 -0.78973858E+01 0.51413298E-01 0.86282977E+01
0.17689472E+02 0.27084188E+02 0.36657552E+02 0.46253383E+02 0.55717063E+02
0.64898313E+02 0.73653855E+02 0.81849887E+02 0.89364344E+02 0.96088881E+02
0.10193057E+03 0.10681323E+03 0.11067846E+03 0.11348624E+03 0.11521523E+03
0.11586261E+03 0.11544365E+03 0.11399089E+03 0.11155304E+03 0.10819353E+03
0.10398888E+03 0.99026864E+02 0.93404459E+02 0.87225735E+02 0.80599650E+02
0.73637846E+02 0.66452460E+02 0.59154022E+02 0.51849465E+02 0.44640290E+02
0.37620922E+02 0.30877278E+02 0.24485577E+02 0.18511398E+02 0.13009009E+02
0.80209530E+01 0.35779043E+01 -0.30122499E+00 -0.36089364E+01 -0.63485770E+01
-0.85335736E+01 -0.10186497E+02 -0.11337984E+02 -0.12025554E+02 -0.12292345E+02
-0.12185805E+02 -0.11756382E+02 -0.11056219E+02 -0.10137909E+02 -0.90533175E+01
-0.78525080E+01 -0.65827802E+01 -0.52878430E+01 -0.40071309E+01 -0.27752721E+01
-0.16217097E+01 -0.57047779E+00 0.35987548E+00 0.11562232E+01 0.18106666E+01
0.23202264E+01 0.26864349E+01 0.29148468E+01 0.30144856E+01 0.29972475E+01
0.28772789E+01 0.26703472E+01 0.23932227E+01 0.20630867E+01 0.16969795E+01
0.13113025E+01 0.92138094E+00 0.54109837E+00 0.18260423E+00 -0.14390035E+00
-0.43029978E+00 -0.67062595E+00 -0.86104898E+00 -0.99980292E+00 -0.10870535E+01
-0.11247164E+01 -0.11162365E+01 -0.10663359E+01 -0.98074332E+00 -0.86591280E+00
-0.72874294E+00 -0.57630417E+00 -0.41558297E+00 -0.25324963E+00 -0.95455204E-01
Real Space Part
0.63319797E+03 0.63291041E+03 0.63204781E+03 0.63061056E+03 0.62859924E+03
0.62601473E+03 0.62285817E+03 0.61913101E+03 0.61483503E+03 0.60997237E+03
0.60454559E+03 0.59855767E+03 0.59201211E+03 0.58491291E+03 0.57726472E+03
0.56907280E+03 0.56034314E+03 0.55108251E+03 0.54129849E+03 0.53099960E+03
0.52019530E+03 0.50889609E+03 0.49711358E+03 0.48486054E+03 0.47215095E+03
0.45900011E+03 0.44542463E+03 0.43144254E+03 0.41707331E+03 0.40233788E+03
0.38725874E+03 0.37185991E+03 0.35616701E+03 0.34020723E+03 0.32400934E+03
0.30760369E+03 0.29102220E+03 0.27429832E+03 0.25746694E+03 0.24056440E+03
0.22362837E+03 0.20669777E+03 0.18981266E+03 0.17301414E+03 0.15634416E+03
0.13984541E+03 0.12356113E+03 0.10753493E+03 0.91810566E+02 0.76431735E+02
0.61441833E+02 0.46883707E+02 0.32799393E+02 0.19229849E+02 0.62146659E+01
-0.62082134E+01 -0.18002788E+02 -0.29135292E+02 -0.39574487E+02 -0.49291950E+02
-0.58262356E+02 -0.66463744E+02 -0.73877778E+02 -0.80489982E+02 -0.86289957E+02
-0.91271581E+02 -0.95433167E+02 -0.98777602E+02 -0.10131245E+03 -0.10305002E+03
-0.10400739E+03 -0.10420642E+03 -0.10367366E+03 -0.10244030E+03 -0.10054203E+03
-0.98018889E+02 -0.94915012E+02 -0.91278431E+02 -0.87160797E+02 -0.82617056E+02
-0.77705128E+02 -0.72485556E+02 -0.67021113E+02 -0.61376433E+02 -0.55617588E+02
-0.49811699E+02 -0.44026502E+02 -0.38329965E+02 -0.32789855E+02 -0.27473361E+02
-0.22446704E+02 -0.17774762E+02 -0.13520724E+02 -0.97457493E+01 -0.65086493E+01
-0.38656440E+01 -0.18700414E+01 -0.57059033E+00 -0.16714955E-01 0.00000000E+00
Non local Part
1 2 1.03170241276447
2.65859946877321 4.88238126795342 4.88238126795342
8.98435195357541
Reciprocal Space Part
0.00000000E+00 0.38861820E+01 0.76566506E+01 0.11198191E+02 0.14402530E+02
0.17168669E+02 0.19405054E+02 0.21031535E+02 0.21981079E+02 0.22201184E+02
0.21654974E+02 0.20321960E+02 0.18198431E+02 0.15297488E+02 0.11648712E+02
0.72974833E+01 0.23039596E+01 -0.32582469E+01 -0.93036735E+01 -0.15736848E+02
-0.22454324E+02 -0.29346862E+02 -0.36301710E+02 -0.43204929E+02 -0.49943706E+02
-0.56408622E+02 -0.62495800E+02 -0.68108907E+02 -0.73160964E+02 -0.77575922E+02
-0.81289979E+02 -0.84252614E+02 -0.86427318E+02 -0.87792019E+02 -0.88339191E+02
-0.88075654E+02 -0.87022084E+02 -0.85212244E+02 -0.82691957E+02 -0.79517866E+02
-0.75756000E+02 -0.71480183E+02 -0.66770345E+02 -0.61710747E+02 -0.56388189E+02
-0.50890222E+02 -0.45303418E+02 -0.39711722E+02 -0.34194931E+02 -0.28827322E+02
-0.23676453E+02 -0.18802168E+02 -0.14255806E+02 -0.10079632E+02 -0.63064936E+01
-0.29596904E+01 -0.53068427E-01 0.24086920E+01 0.44295991E+01 0.60217087E+01
0.72043400E+01 0.80031754E+01 0.84492707E+01 0.85780039E+01 0.84279913E+01
0.80399981E+01 0.74558696E+01 0.67175093E+01 0.58659233E+01 0.49403528E+01
0.39775094E+01 0.30109262E+01 0.20704331E+01 0.11817624E+01 0.36628567E+00
-0.35911990E+00 -0.98208097E+00 -0.14946211E+01 -0.18929483E+01 -0.21771504E+01
-0.23508116E+01 -0.24205674E+01 -0.23956133E+01 -0.22871843E+01 -0.21080214E+01
-0.18718417E+01 -0.15928247E+01 -0.12851305E+01 -0.96245910E+00 -0.63766179E+00
-0.32241090E+00 -0.26933951E-01 0.24018535E+00 0.47213831E+00 0.66395584E+00
0.81250966E+00 0.91645487E+00 0.97612004E+00 0.99335246E+00 0.97132649E+00
Real Space Part
0.00000000E+00 -0.22186814E+02 -0.44301839E+02 -0.66273522E+02 -0.88030777E+02
-0.10950322E+03 -0.13062140E+03 -0.15131703E+03 -0.17152321E+03 -0.19117468E+03
-0.21020799E+03 -0.22856176E+03 -0.24617690E+03 -0.26299679E+03 -0.27896751E+03
-0.29403802E+03 -0.30816039E+03 -0.32128994E+03 -0.33338548E+03 -0.34440943E+03
-0.35432799E+03 -0.36311136E+03 -0.37073379E+03 -0.37717380E+03 -0.38241426E+03
-0.38644250E+03 -0.38925046E+03 -0.39083470E+03 -0.39119654E+03 -0.39034209E+03
-0.38828229E+03 -0.38503293E+03 -0.38061467E+03 -0.37505301E+03 -0.36837826E+03
-0.36062551E+03 -0.35183450E+03 -0.34204958E+03 -0.33131954E+03 -0.31969747E+03
-0.30724063E+03 -0.29401017E+03 -0.28007097E+03 -0.26549136E+03 -0.25034283E+03
-0.23469974E+03 -0.21863898E+03 -0.20223959E+03 -0.18558239E+03 -0.16874958E+03
-0.15182426E+03 -0.13489000E+03 -0.11803038E+03 -0.10132845E+03 -0.84866250E+02
-0.68724282E+02 -0.52980979E+02 -0.37712173E+02 -0.22990566E+02 -0.88851973E+01
0.45390663E+01 0.17222034E+02 0.29108671E+02 0.40149550E+02 0.50301273E+02
0.59526856E+02 0.67796071E+02 0.75085739E+02 0.81379975E+02 0.86670373E+02
0.90956134E+02 0.94244139E+02 0.96548944E+02 0.97892719E+02 0.98305121E+02
0.97823113E+02 0.96490698E+02 0.94358601E+02 0.91483927E+02 0.87929701E+02
0.83764422E+02 0.79061549E+02 0.73898935E+02 0.68358280E+02 0.62524490E+02
0.56485105E+02 0.50329625E+02 0.44148922E+02 0.38034576E+02 0.32078283E+02
0.26371234E+02 0.21003526E+02 0.16063609E+02 0.11637728E+02 0.78094126E+01
0.46590409E+01 0.22633368E+01 0.69369210E+00 0.17747648E-01 0.00000000E+00
Reciprocal Space Part
0.00000000E+00 -0.17868362E+01 -0.35144269E+01 -0.51248277E+01 -0.65626676E+01
-0.77763629E+01 -0.87192468E+01 -0.93505888E+01 -0.96364809E+01 -0.95505728E+01
-0.90746384E+01 -0.81989629E+01 -0.69225426E+01 -0.52530936E+01 -0.32068705E+01
-0.80830207E+00 0.19105496E+01 0.49106895E+01 0.81470351E+01 0.11569385E+02
0.15123488E+02 0.18752190E+02 0.22396628E+02 0.25997448E+02 0.29496018E+02
0.32835608E+02 0.35962514E+02 0.38827099E+02 0.41384736E+02 0.43596618E+02
0.45430445E+02 0.46860950E+02 0.47870266E+02 0.48448142E+02 0.48591976E+02
0.48306705E+02 0.47604523E+02 0.46504469E+02 0.45031872E+02 0.43217686E+02
0.41097721E+02 0.38711805E+02 0.36102874E+02 0.33316045E+02 0.30397658E+02
0.27394336E+02 0.24352070E+02 0.21315355E+02 0.18326389E+02 0.15424354E+02
0.12644790E+02 0.10019079E+02 0.75740326E+01 0.53316035E+01 0.33087123E+01
0.15171909E+01 -0.36159418E-01 -0.13494048E+01 -0.24252171E+01 -0.32705252E+01
-0.38960921E+01 -0.43160309E+01 -0.45472742E+01 -0.46090120E+01 -0.45221135E+01
-0.43085463E+01 -0.39908088E+01 -0.35913863E+01 -0.31322454E+01 -0.26343746E+01
-0.21173800E+01 -0.15991441E+01 -0.10955499E+01 -0.62027500E+00 -0.18465580E+00
0.20237976E+00 0.53431322E+00 0.80697500E+00 0.10184279E+01 0.11688016E+01
0.12600861E+01 0.12958921E+01 0.12811875E+01 0.12220191E+01 0.11252269E+01
0.99816176E+00 0.84841124E+00 0.68354309E+00 0.51087098E+00 0.33724795E+00
0.16889148E+00 0.11242749E-01 -0.13113830E+00 -0.25464171E+00 -0.35664077E+00
-0.43549155E+00 -0.49050126E+00 -0.52186870E+00 -0.53060095E+00 -0.51841055E+00
Real Space Part
0.00000000E+00 0.12161252E+02 0.24283469E+02 0.36327742E+02 0.48255417E+02
0.60028220E+02 0.71608383E+02 0.82958767E+02 0.94042991E+02 0.10482555E+03
0.11527193E+03 0.12534873E+03 0.13502381E+03 0.14426635E+03 0.15304699E+03
0.16133795E+03 0.16911311E+03 0.17634814E+03 0.18302057E+03 0.18910990E+03
0.19459770E+03 0.19946767E+03 0.20370573E+03 0.20730009E+03 0.21024135E+03
0.21252251E+03 0.21413905E+03 0.21508898E+03 0.21537287E+03 0.21499392E+03
0.21395789E+03 0.21227322E+03 0.20995096E+03 0.20700481E+03 0.20345105E+03
0.19930856E+03 0.19459875E+03 0.18934552E+03 0.18357519E+03 0.17731641E+03
0.17060007E+03 0.16345921E+03 0.15592887E+03 0.14804598E+03 0.13984918E+03
0.13137868E+03 0.12267606E+03 0.11378408E+03 0.10474648E+03 0.95607747E+02
0.86412883E+02 0.77207157E+02 0.68035844E+02 0.58943963E+02 0.49976000E+02
0.41175622E+02 0.32585400E+02 0.24246514E+02 0.16198468E+02 0.84788075E+01
0.11228377E+01 -0.58366451E+01 -0.12369614E+02 -0.18449055E+02 -0.24051197E+02
-0.29155721E+02 -0.33745943E+02 -0.37808973E+02 -0.41335852E+02 -0.44321651E+02
-0.46765541E+02 -0.48670833E+02 -0.50044982E+02 -0.50899549E+02 -0.51250136E+02
-0.51116295E+02 -0.50521380E+02 -0.49492378E+02 -0.48059729E+02 -0.46257077E+02
-0.44121031E+02 -0.41690892E+02 -0.39008342E+02 -0.36117160E+02 -0.33062867E+02
-0.29892426E+02 -0.26653874E+02 -0.23396010E+02 -0.20168034E+02 -0.17019231E+02
-0.13998631E+02 -0.11154698E+02 -0.85350264E+01 -0.61860453E+01 -0.41527388E+01
-0.24784108E+01 -0.12044157E+01 -0.36926989E+00 -0.93979993E-02 0.00000000E+00
PAW radial sets
351 0.989218471734280
(5E20.12)
augmentation charges (non sperical)
-0.118612820244E+00 -0.166184190184E+00 -0.532145144881E-01 -0.101222164724E+00 -0.166184190184E+00
-0.232848406670E+00 -0.743582353105E-01 -0.141431561143E+00 -0.532145144881E-01 -0.743582353105E-01
-0.179689550405E-01 -0.343505440708E-01 -0.101222164724E+00 -0.141431561143E+00 -0.343505440708E-01
-0.655142723317E-01
uccopancies in atom
0.200000000235E+01 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.666666668254E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00
grid
0.353278105438E-04 0.364765828105E-04 0.376627102856E-04 0.388874076671E-04 0.401519291522E-04
0.414575697215E-04 0.428056664648E-04 0.441975999512E-04 0.456347956421E-04 0.471187253514E-04
0.486509087530E-04 0.502329149365E-04 0.518663640144E-04 0.535529287814E-04 0.552943364272E-04
0.570923703053E-04 0.589488717596E-04 0.608657420098E-04 0.628449440985E-04 0.648885049016E-04
0.669985172040E-04 0.691771418426E-04 0.714266099194E-04 0.737492250864E-04 0.761473659044E-04
0.786234882792E-04 0.811801279764E-04 0.838199032186E-04 0.865455173661E-04 0.893597616862E-04
0.922655182109E-04 0.952657626888E-04 0.983635676325E-04 0.101562105465E-03 0.104864651768E-03
0.108274588638E-03 0.111795408149E-03 0.115430715926E-03 0.119184234844E-03 0.123059808833E-03
0.127061406819E-03 0.131193126789E-03 0.135459199986E-03 0.139863995240E-03 0.144412023447E-03
0.149107942186E-03 0.153956560487E-03 0.158962843759E-03 0.164131918874E-03 0.169469079417E-03
0.174979791106E-03 0.180669697392E-03 0.186544625235E-03 0.192610591076E-03 0.198873806993E-03
0.205340687067E-03 0.212017853948E-03 0.218912145639E-03 0.226030622496E-03 0.233380574462E-03
0.240969528530E-03 0.248805256452E-03 0.256895782699E-03 0.265249392676E-03 0.273874641209E-03
0.282780361308E-03 0.291975673207E-03 0.301469993709E-03 0.311273045829E-03 0.321394868748E-03
0.331845828098E-03 0.342636626573E-03 0.353778314896E-03 0.365282303127E-03 0.377160372357E-03
0.389424686766E-03 0.402087806084E-03 0.415162698451E-03 0.428662753701E-03 0.442601797068E-03
0.456994103352E-03 0.471854411533E-03 0.487197939863E-03 0.503040401457E-03 0.519398020380E-03
0.536287548263E-03 0.553726281459E-03 0.571732078754E-03 0.590323379658E-03 0.609519223288E-03
0.629339267864E-03 0.649803810846E-03 0.670933809712E-03 0.692750903429E-03 0.715277434606E-03
0.738536472381E-03 0.762551836040E-03 0.787348119413E-03 0.812950716063E-03 0.839385845286E-03
0.866680578963E-03 0.894862869287E-03 0.923961577387E-03 0.954006502881E-03 0.985028414399E-03
0.101705908109E-02 0.105013130516E-02 0.108427895544E-02 0.111953700213E-02 0.115594155253E-02
0.119352988810E-02 0.123234050257E-02 0.127241314140E-02 0.131378884247E-02 0.135650997813E-02
0.140062029854E-02 0.144616497653E-02 0.149319065382E-02 0.154174548883E-02 0.159187920594E-02
0.164364314647E-02 0.169709032120E-02 0.175227546473E-02 0.180925509145E-02 0.186808755348E-02
0.192883310041E-02 0.199155394099E-02 0.205631430683E-02 0.212318051821E-02 0.219222105197E-02
0.226350661166E-02 0.233711019991E-02 0.241310719324E-02 0.249157541920E-02 0.257259523611E-02
0.265624961535E-02 0.274262422631E-02 0.283180752413E-02 0.292389084032E-02 0.301896847624E-02
0.311713779968E-02 0.321849934462E-02 0.332315691413E-02 0.343121768671E-02 0.354279232604E-02
0.365799509430E-02 0.377694396919E-02 0.389976076474E-02 0.402657125610E-02 0.415750530828E-02
0.429269700920E-02 0.443228480697E-02 0.457641165169E-02 0.472522514185E-02 0.487887767547E-02
0.503752660617E-02 0.520133440431E-02 0.537046882339E-02 0.554510307185E-02 0.572541599040E-02
0.591159223525E-02 0.610382246712E-02 0.630230354657E-02 0.650723873558E-02 0.671883790569E-02
0.693731775293E-02 0.716290201977E-02 0.739582172419E-02 0.763631539635E-02 0.788462932276E-02
0.814101779859E-02 0.840574338805E-02 0.867907719326E-02 0.896129913194E-02 0.925269822400E-02
0.955357288758E-02 0.986423124464E-02 0.101849914365E-01 0.105161819495E-01 0.108581419519E-01
0.112112216404E-01 0.115757825996E-01 0.119521981717E-01 0.123408538391E-01 0.127421476193E-01
0.131564904721E-01 0.135843067208E-01 0.140260344867E-01 0.144821261375E-01 0.149530487510E-01
0.154392845931E-01 0.159413316118E-01 0.164597039470E-01 0.169949324574E-01 0.175475652638E-01
0.181181683104E-01 0.187073259445E-01 0.193156415151E-01 0.199437379906E-01 0.205922585965E-01
0.212618674747E-01 0.219532503631E-01 0.226671152982E-01 0.234041933402E-01 0.241652393213E-01
0.249510326191E-01 0.257623779547E-01 0.266001062165E-01 0.274650753115E-01 0.283581710436E-01
0.292803080210E-01 0.302324305924E-01 0.312155138146E-01 0.322305644506E-01 0.332786220011E-01
0.343607597686E-01 0.354780859567E-01 0.366317448050E-01 0.378229177610E-01 0.390528246900E-01
0.403227251240E-01 0.416339195521E-01 0.429877507520E-01 0.443856051652E-01 0.458289143166E-01
0.473191562810E-01 0.488578571964E-01 0.504465928270E-01 0.520869901769E-01 0.537807291563E-01
0.555295443019E-01 0.573352265534E-01 0.591996250870E-01 0.611246492098E-01 0.631122703148E-01
0.651645238996E-01 0.672835116512E-01 0.694714035982E-01 0.717304403333E-01 0.740629353074E-01
0.764712771991E-01 0.789579323611E-01 0.815254473456E-01 0.841764515121E-01 0.869136597208E-01
0.897398751118E-01 0.926579919768E-01 0.956709987225E-01 0.987819809310E-01 0.101994124520E+00
0.105310719005E+00 0.108735160869E+00 0.112270957040E+00 0.115921728481E+00 0.119691213902E+00
0.123583273585E+00 0.127601893339E+00 0.131751188583E+00 0.136035408556E+00 0.140458940676E+00
0.145026315024E+00 0.149742208992E+00 0.154611452068E+00 0.159639030781E+00 0.164830093811E+00
0.170189957261E+00 0.175724110099E+00 0.181438219781E+00 0.187338138056E+00 0.193429906954E+00
0.199719764979E+00 0.206214153496E+00 0.212919723327E+00 0.219843341560E+00 0.226992098585E+00
0.234373315355E+00 0.241994550880E+00 0.249863609972E+00 0.257988551235E+00 0.266377695319E+00
0.275039633439E+00 0.283983236179E+00 0.293217662568E+00 0.302752369466E+00 0.312597121246E+00
0.322761999795E+00 0.333257414835E+00 0.344094114590E+00 0.355283196787E+00 0.366836120023E+00
0.378764715502E+00 0.391081199148E+00 0.403798184116E+00 0.416928693710E+00 0.430486174720E+00
0.444484511190E+00 0.458938038641E+00 0.473861558747E+00 0.489270354497E+00 0.505180205845E+00
0.521607405869E+00 0.538568777456E+00 0.556081690535E+00 0.574164079857E+00 0.592834463369E+00
0.612111961177E+00 0.632016315122E+00 0.652567909002E+00 0.673787789445E+00 0.695697687463E+00
0.718320040705E+00 0.741678016440E+00 0.765795535274E+00 0.790697295655E+00 0.816408799161E+00
0.842956376619E+00 0.870367215068E+00 0.898669385601E+00 0.927891872115E+00 0.958064600989E+00
0.989218471734E+00 0.102138538864E+01 0.105459829343E+01 0.108889119903E+01 0.112429922437E+01
0.116085863037E+01 0.119860685704E+01 0.123758256187E+01 0.127782565939E+01 0.131937736205E+01
0.136228022242E+01 0.140657817678E+01 0.145231659010E+01 0.149954230253E+01 0.154830367731E+01
0.159865065035E+01 0.165063478135E+01 0.170430930661E+01 0.175972919353E+01 0.181695119691E+01
0.187603391710E+01 0.193703785995E+01 0.200002549884E+01 0.206506133861E+01 0.213221198164E+01
0.220154619607E+01 0.227313498618E+01 0.234705166515E+01 0.242337193012E+01 0.250217393971E+01
0.258353839407E+01
aepotential
0.249296947974E+05 0.247076561026E+05 0.244443313547E+05 0.241414253640E+05 0.238012309740E+05
0.234259813678E+05 0.230181043480E+05 0.225809961616E+05 0.221166800594E+05 0.216286109490E+05
0.211196171324E+05 0.205927134571E+05 0.200508445329E+05 0.194969963033E+05 0.189339771311E+05
0.183645026186E+05 0.177912890443E+05 0.172167064663E+05 0.166431270260E+05 0.160726862779E+05
0.155073402250E+05 0.149488848247E+05 0.143989117768E+05 0.138588393857E+05 0.133298963598E+05
0.128131392341E+05 0.123094542557E+05 0.118195679465E+05 0.113440551010E+05 0.108833506728E+05
0.104377601662E+05 0.100074714858E+05 0.959256622382E+04 0.919303113611E+04 0.880876923400E+04
0.843961046952E+04 0.808532192877E+04 0.774561726178E+04 0.742016531312E+04 0.710859980992E+04
0.681052312014E+04 0.652551855157E+04 0.625315022209E+04 0.599297269034E+04 0.574453507071E+04
0.550738155297E+04 0.528105943435E+04 0.506512283908E+04 0.485912669119E+04 0.466263692016E+04
0.447523241993E+04 0.429649920031E+04 0.412604217009E+04 0.396347085357E+04 0.380841736718E+04
0.366052059215E+04 0.351943998366E+04 0.338484550824E+04 0.325642075114E+04 0.313386784458E+04
0.301689601724E+04 0.290523717951E+04 0.279862371984E+04 0.269681383135E+04 0.259956791482E+04
0.250666289932E+04 0.241788601403E+04 0.233303530109E+04 0.225191811134E+04 0.217435346238E+04
0.210016749107E+04 0.202919681943E+04 0.196128648905E+04 0.189628781912E+04 0.183406428064E+04
0.177447815378E+04 0.171741030060E+04 0.166273352875E+04 0.161034457319E+04 0.156012716492E+04
0.151198483922E+04 0.146582052759E+04 0.142154086395E+04 0.137906097148E+04 0.133829797002E+04
0.129917207490E+04 0.126161128619E+04 0.122554324807E+04 0.119090137554E+04 0.115762273768E+04
0.112564519634E+04 0.109491260230E+04 0.106536958529E+04 0.103696376209E+04 0.100964626874E+04
0.983369386517E+03 0.958088259270E+03 0.933760491469E+03 0.910344918809E+03 0.887802999165E+03
0.866097688492E+03 0.845193722659E+03 0.825057486722E+03 0.805656949235E+03 0.786961460988E+03
0.768941860254E+03 0.751570280175E+03 0.734820058649E+03 0.718665839953E+03 0.703083242035E+03
0.688049142095E+03 0.673541285748E+03 0.659538404365E+03 0.646020181485E+03 0.632967306499E+03
0.620361030724E+03 0.608183507242E+03 0.596417880177E+03 0.585047538181E+03 0.574057005309E+03
0.563431167138E+03 0.553155596176E+03 0.543216472219E+03 0.533600577089E+03 0.524295096628E+03
0.515287864004E+03 0.506567108698E+03 0.498121462758E+03 0.489940202519E+03 0.482012792804E+03
0.474329218497E+03 0.466879807157E+03 0.459655277491E+03 0.452646665244E+03 0.445845326919E+03
0.439242971301E+03 0.432831556708E+03 0.426603373307E+03 0.420550954576E+03 0.414667100840E+03
0.408944864593E+03 0.403377536754E+03 0.397958629585E+03 0.392681872509E+03 0.387541205851E+03
0.382530758167E+03 0.377644862756E+03 0.372878015893E+03 0.368224898594E+03 0.363680350460E+03
0.359239371823E+03 0.354897097109E+03 0.350648847402E+03 0.346490028292E+03 0.342416224923E+03
0.338423107351E+03 0.334506504401E+03 0.330662319969E+03 0.326886614027E+03 0.323175521883E+03
0.319525291137E+03 0.315932256738E+03 0.312392876939E+03 0.308903660561E+03 0.305461237806E+03
0.302062300261E+03 0.298703633981E+03 0.295382095296E+03 0.292094620152E+03 0.288838215885E+03
0.285609957558E+03 0.282406996490E+03 0.279226542503E+03 0.276065876855E+03 0.272922339966E+03
0.269793336953E+03 0.266676334707E+03 0.263568857552E+03 0.260468492389E+03 0.257372882929E+03
0.254279731763E+03 0.251186799954E+03 0.248091907223E+03 0.244992930370E+03 0.241887805727E+03
0.238774528474E+03 0.235651153907E+03 0.232515797559E+03 0.229366637373E+03 0.226201914200E+03
0.223019933142E+03 0.219819066345E+03 0.216597753942E+03 0.213354506528E+03 0.210087907601E+03
0.206796615859E+03 0.203479368741E+03 0.200134985511E+03 0.196762369494E+03 0.193360514156E+03
0.189928504953E+03 0.186465523853E+03 0.182970859195E+03 0.179443901362E+03 0.175884158862E+03
0.172291258360E+03 0.168664954571E+03 0.165005135639E+03 0.161311835637E+03 0.157585240450E+03
0.153825700617E+03 0.150033742009E+03 0.146210080614E+03 0.142355636015E+03 0.138471547517E+03
0.134559194204E+03 0.130620213523E+03 0.126656524279E+03 0.122670351092E+03 0.118664249894E+03
0.114641136764E+03 0.110604316344E+03 0.106557510777E+03 0.102504888129E+03 0.984510866673E+02
0.944012339330E+02 0.903609560496E+02 0.863363727654E+02 0.823340720461E+02 0.783610582152E+02
0.744246635302E+02 0.705324163825E+02 0.666918556889E+02 0.629102857223E+02 0.591944670209E+02
0.555502478406E+02 0.519821533052E+02 0.484929672889E+02 0.450833747727E+02 0.417517679667E+02
0.384943736779E+02 0.353058990617E+02 0.321809409707E+02 0.291163273793E+02 0.261144332192E+02
0.231871490568E+02 0.203596536608E+02 0.176726023843E+02 0.151810750610E+02 0.129490421852E+02
0.110393419844E+02 0.950085960920E+01 0.835601618665E+01 0.759220066468E+01 0.716026999428E+01
0.698171626746E+01 0.696337605625E+01 0.701521103097E+01 0.706481640894E+01 0.706399982574E+01
0.698712687429E+01 0.682461396109E+01 0.657568919727E+01 0.624298320013E+01 0.582958771078E+01
0.533805431630E+01 0.477041539462E+01 0.412860168459E+01 0.341481102932E+01 0.263171179070E+01
0.178246356837E+01 0.870634857094E+00 -0.999435655628E-01 -0.112531912148E+01 -0.220152950825E+01
-0.332469240511E+01 -0.449104627091E+01 -0.569696900609E+01 -0.693897492393E+01 -0.821369212013E+01
-0.951782569431E+01 -0.108481106853E+02 -0.122012544483E+02 -0.135738672328E+02 -0.149623731041E+02
-0.163629117637E+02 -0.177712183098E+02 -0.191824857852E+02 -0.205912204531E+02 -0.219910948777E+02
-0.233748286767E+02 -0.247341319073E+02 -0.260597523206E+02 -0.273417023275E+02 -0.285696934068E+02
-0.297338412853E+02 -0.308256304858E+02 -0.318391158428E+02 -0.327722938273E+02 -0.336286100568E+02
-0.344184456425E+02 -0.351602597585E+02 -0.358801414497E+02 -0.366068311139E+02 -0.373574865876E+02
-0.381118852062E+02 -0.387867275622E+02 -0.392441858557E+02 -0.393634905455E+02 -0.391349287148E+02
-0.386756213346E+02 -0.381417405135E+02 -0.376357899161E+02 -0.371876084550E+02 -0.367857306580E+02
-0.364089018964E+02 -0.360404071207E+02 -0.356705439437E+02 -0.352947736228E+02 -0.349113814513E+02
-0.345198082255E+02 -0.341197553652E+02 -0.337108267652E+02 -0.332925072698E+02 -0.328642387355E+02
-0.324255741088E+02 -0.319762374262E+02 -0.315162189773E+02 -0.310457677673E+02 -0.305653859428E+02
-0.300757994671E+02 -0.295778859655E+02 -0.290726427811E+02 -0.285611001088E+02 -0.280442533230E+02
-0.275230192225E+02 -0.269981679715E+02 -0.264702980396E+02 -0.259398216884E+02 -0.254069826533E+02
-0.248718994035E+02 -0.243346314120E+02 -0.237952586509E+02 -0.232539624826E+02 -0.227110955590E+02
-0.221672327097E+02 -0.216231877485E+02 -0.210800244667E+02 -0.205390174919E+02 -0.200016158604E+02
-0.194693867508E+02
core charge-density
0.566100408154E-04 0.603274793074E-04 0.642889044283E-04 0.685103166568E-04 0.730087644875E-04
0.778024129493E-04 0.829106165872E-04 0.883539971990E-04 0.941545266560E-04 0.100335615085E-03
0.106922204822E-03 0.113940870473E-03 0.121419925474E-03 0.129389535603E-03 0.137881839861E-03
0.146931079213E-03 0.156573733698E-03 0.166848668447E-03 0.177797289174E-03 0.189463707768E-03
0.201894918628E-03 0.215140986428E-03 0.229255246056E-03 0.244294515512E-03 0.260319322588E-03
0.277394146221E-03 0.295587673465E-03 0.314973073077E-03 0.335628286780E-03 0.357636339348E-03
0.381085668699E-03 0.406070477287E-03 0.432691106152E-03 0.461054433064E-03 0.491274296314E-03
0.523471945761E-03 0.557776522887E-03 0.594325571702E-03 0.633265582435E-03 0.674752570119E-03
0.718952690251E-03 0.766042893893E-03 0.816211624674E-03 0.869659560374E-03 0.926600401855E-03
0.987261712339E-03 0.105188581019E-02 0.112073071853E-02 0.119407117529E-02 0.127219970739E-02
0.135542777315E-02 0.144408697705E-02 0.153853036146E-02 0.163913378001E-02 0.174629735768E-02
0.186044704296E-02 0.198203625776E-02 0.211154765105E-02 0.224949496259E-02 0.239642500343E-02
0.255291976042E-02 0.271959863213E-02 0.289712080418E-02 0.308618777247E-02 0.328754602307E-02
0.350198987838E-02 0.373036451926E-02 0.397356919385E-02 0.423256062398E-02 0.450835662100E-02
0.480203992329E-02 0.511476226845E-02 0.544774871395E-02 0.580230222061E-02 0.617980851421E-02
0.658174124108E-02 0.700966743491E-02 0.746525331166E-02 0.795027041269E-02 0.846660211345E-02
0.901625052094E-02 0.960134377894E-02 0.102241438053E-01 0.108870544842E-01 0.115926303386E-01
0.123435857075E-01 0.131428044576E-01 0.139933502544E-01 0.148984774251E-01 0.158616424421E-01
0.168865160593E-01 0.179769961364E-01 0.191372211820E-01 0.203715846550E-01 0.216847500588E-01
0.230816668678E-01 0.245675873256E-01 0.261480841549E-01 0.278290692218E-01 0.296168131969E-01
0.315179662576E-01 0.335395798759E-01 0.356891297379E-01 0.379745398409E-01 0.404042078155E-01
0.429870315194E-01 0.457324369501E-01 0.486504075246E-01 0.517515147717E-01 0.550469504838E-01
0.585485603728E-01 0.622688792735E-01 0.662211679360E-01 0.704194514465E-01 0.748785593126E-01
0.796141672432E-01 0.846428406544E-01 0.899820799218E-01 0.956503673943E-01 0.101667216183E+00
0.108053220723E+00 0.114830109098E+00 0.122020797119E+00 0.129649444112E+00 0.137741510382E+00
0.146323816290E+00 0.155424602864E+00 0.165073593849E+00 0.175302059090E+00 0.186142879083E+00
0.197630610560E+00 0.209801552888E+00 0.222693815062E+00 0.236347383047E+00 0.250804187144E+00
0.266108169064E+00 0.282305348315E+00 0.299443887476E+00 0.317574155859E+00 0.336748791043E+00
0.357022757646E+00 0.378453402702E+00 0.401100506871E+00 0.425026330694E+00 0.450295654993E+00
0.476975814429E+00 0.505136723178E+00 0.534850891530E+00 0.566193432183E+00 0.599242054859E+00
0.634077047765E+00 0.670781244335E+00 0.709439973560E+00 0.750140992075E+00 0.792974396116E+00
0.838032511244E+00 0.885409757763E+00 0.935202489441E+00 0.987508803254E+00 0.104242831757E+01
0.110006191624E+01 0.116051145584E+01 0.122387943346E+01 0.129026861193E+01 0.135978160000E+01
0.143252038425E+01 0.150858581009E+01 0.158807700896E+01 0.167109076893E+01 0.175772084621E+01
0.184805721494E+01 0.194218525332E+01 0.204018486382E+01 0.214212952620E+01 0.224808528199E+01
0.235810964998E+01 0.247225047259E+01 0.259054469391E+01 0.271301707089E+01 0.283967882006E+01
0.297052620347E+01 0.310553905827E+01 0.324467927606E+01 0.338788923929E+01 0.353509022378E+01
0.368618077801E+01 0.384103509149E+01 0.399950136699E+01 0.416140021288E+01 0.432652307442E+01
0.449463072490E+01 0.466545184006E+01 0.483868168119E+01 0.501398091525E+01 0.519097460207E+01
0.536925138135E+01 0.554836289419E+01 0.572782347558E+01 0.590711015619E+01 0.608566301289E+01
0.626288590845E+01 0.643814766086E+01 0.661078368325E+01 0.678009813289E+01 0.694536660815E+01
0.710583942709E+01 0.726074551989E+01 0.740929696058E+01 0.755069415923E+01 0.768413172658E+01
0.780880501609E+01 0.792391733716E+01 0.802868782233E+01 0.812235991814E+01 0.820421045514E+01
0.827355923749E+01 0.832977907498E+01 0.837230616406E+01 0.840065070529E+01 0.841440762640E+01
0.841326726196E+01 0.839702582182E+01 0.836559546387E+01 0.831901377096E+01 0.825745241774E+01
0.818122480318E+01 0.809079241634E+01 0.798676970036E+01 0.786992718088E+01 0.774119263277E+01
0.760165007160E+01 0.745253637713E+01 0.729523538244E+01 0.713126929714E+01 0.696228737445E+01
0.679005178084E+01 0.661642068236E+01 0.644332862226E+01 0.627276433103E+01 0.610674617685E+01
0.594729553438E+01 0.579640841756E+01 0.565602577058E+01 0.552800288253E+01 0.541407841905E+01
0.531584356652E+01 0.523471181475E+01 0.517188988547E+01 0.512835031200E+01 0.510480618875E+01
0.510168864942E+01 0.511912769994E+01 0.515693711116E+01 0.521460413879E+01 0.529128484590E+01
0.538580571386E+01 0.549667199677E+01 0.562208291152E+01 0.575995334559E+01 0.590794145701E+01
0.606348143532E+01 0.622382075557E+01 0.638606135679E+01 0.654720421042E+01 0.670419668250E+01
0.685398197262E+01 0.699354974359E+01 0.711998698134E+01 0.723052801287E+01 0.732260261476E+01
0.739388115435E+01 0.744231577198E+01 0.746617668668E+01 0.746408283670E+01 0.743502617611E+01
0.737838909120E+01 0.729395456103E+01 0.718190882688E+01 0.704283651135E+01 0.687770827554E+01
0.668786127413E+01 0.647497281612E+01 0.624102777379E+01 0.598828043165E+01 0.571921157955E+01
0.543648173800E+01 0.514288151879E+01 0.484128016393E+01 0.453457335746E+01 0.422563144517E+01
0.391724918675E+01 0.361209817668E+01 0.331268302840E+01 0.302130238260E+01 0.274001574527E+01
0.247061699977E+01 0.221461533156E+01 0.197322403846E+01 0.174735751206E+01 0.153763599448E+01
0.134439801278E+01 0.116771925944E+01 0.100743683521E+01 0.863177139249E+00 0.734385165797E+00
0.620352459116E+00 0.520241286779E+00 0.433104991178E+00 0.357908936157E+00 0.293558957004E+00
0.238939321053E+00 0.192952592630E+00 0.154550553295E+00 0.122752018839E+00 0.966509407173E-01
0.754197350591E-01 0.583105682925E-01 0.446553131657E-01 0.338641471811E-01 0.254227490621E-01
0.188882113068E-01 0.138839137385E-01 0.100936590292E-01 0.725537509450E-02 0.515466309716E-02
0.361842930266E-02 0.250879268147E-02 0.171741309607E-02 0.116033964584E-02 0.773437417305E-03
0.508414784907E-03 0.329443540380E-03 0.210340978410E-03 0.132266603092E-03 0.818759218551E-04
0.498690344207E-04 0.298714443437E-04 0.175875916060E-04 0.101729842592E-04 0.577752330293E-05
0.321986957660E-05 0.175987680434E-05 0.942778890139E-06 0.494707936977E-06 0.254108048780E-06
0.127681574306E-06 0.627159654587E-07 0.300924318689E-07 0.140943050873E-07 0.643877401768E-08
0.286674509825E-08
kinetic energy-density
0.667225310700E+01 0.673712425060E+01 0.680446712075E+01 0.687435266836E+01 0.694687887984E+01
0.702214082218E+01 0.710025487509E+01 0.718131997169E+01 0.726545491156E+01 0.735279351610E+01
0.744345621126E+01 0.753759398662E+01 0.763534237524E+01 0.773686628737E+01 0.784232168333E+01
0.795188785384E+01 0.806574492238E+01 0.818408265740E+01 0.830710733444E+01 0.843502925423E+01
0.856807463323E+01 0.870648022710E+01 0.885049499152E+01 0.900038141274E+01 0.915641556867E+01
0.931888763846E+01 0.948810409274E+01 0.966438660997E+01 0.984807420966E+01 0.100395236808E+02
0.102391106259E+02 0.104472306217E+02 0.106643002129E+02 0.108907581658E+02 0.111270667128E+02
0.113737129173E+02 0.116312100590E+02 0.119000995563E+02 0.121809512045E+02 0.124743676751E+02
0.127809824020E+02 0.131014661587E+02 0.134365246352E+02 0.137869037259E+02 0.141533910827E+02
0.145368181700E+02 0.149380606607E+02 0.153580481103E+02 0.157977592006E+02 0.162582301660E+02
0.167405536651E+02 0.172458849260E+02 0.177754489910E+02 0.183305360512E+02 0.189125147524E+02
0.195228293783E+02 0.201630086713E+02 0.208346731063E+02 0.215395302738E+02 0.222793960940E+02
0.230561817871E+02 0.238719218157E+02 0.247287599035E+02 0.256289715181E+02 0.265749638623E+02
0.275692850611E+02 0.286146340209E+02 0.297138695051E+02 0.308700182642E+02 0.320862867047E+02
0.333660717388E+02 0.347129698754E+02 0.361307926843E+02 0.376235764044E+02 0.391956004794E+02
0.408513960801E+02 0.425957666062E+02 0.444337942387E+02 0.463708781148E+02 0.484127240612E+02
0.505653883328E+02 0.528352819288E+02 0.552292043731E+02 0.577543512402E+02 0.604183612533E+02
0.632293138540E+02 0.661957773286E+02 0.693268340532E+02 0.726320939962E+02 0.761217542966E+02
0.798066090433E+02 0.836980910427E+02 0.878083249418E+02 0.921501355979E+02 0.967371238079E+02
0.101583684198E+03 0.106705064907E+03 0.112117414382E+03 0.117837828166E+03 0.123884409252E+03
0.130276320038E+03 0.137033846315E+03 0.144178456681E+03 0.151732871301E+03 0.159721130996E+03
0.168168668145E+03 0.177102387622E+03 0.186550741797E+03 0.196543819667E+03 0.207113432275E+03
0.218293201433E+03 0.230118672341E+03 0.242627385569E+03 0.255859010707E+03 0.269855440106E+03
0.284660908978E+03 0.300322108546E+03 0.316888318424E+03 0.334411529406E+03 0.352946573140E+03
0.372551274533E+03 0.393286576958E+03 0.415216695313E+03 0.438409280187E+03 0.462935557123E+03
0.488870494758E+03 0.516292978425E+03 0.545285959475E+03 0.575936645981E+03 0.608336673183E+03
0.642582272764E+03 0.678774465893E+03 0.717019234895E+03 0.757427713585E+03 0.800116365041E+03
0.845207163513E+03 0.892827774214E+03 0.943111730250E+03 0.996198604607E+03 0.105223417127E+04
0.111137056935E+04 0.117376644321E+04 0.123958708989E+04 0.130900456745E+04 0.138219781473E+04
0.145935272609E+04 0.154066222765E+04 0.162632630841E+04 0.171655203448E+04 0.181155353272E+04
0.191155192916E+04 0.201677522893E+04 0.212745822677E+04 0.224384225326E+04 0.236617496487E+04
0.249470999554E+04 0.262970664059E+04 0.277142932316E+04 0.292014710882E+04 0.307613311454E+04
0.323966371690E+04 0.341101780179E+04 0.359047581918E+04 0.377831874540E+04 0.397482689787E+04
0.418027868224E+04 0.439494910623E+04 0.461910823060E+04 0.485301940433E+04 0.509693739042E+04
0.535110624785E+04 0.561575714459E+04 0.589110587709E+04 0.617735029231E+04 0.647466747894E+04
0.678321077715E+04 0.710310660594E+04 0.743445110603E+04 0.777730657840E+04 0.813169778138E+04
0.849760803098E+04 0.887497515215E+04 0.926368732206E+04 0.966357873788E+04 0.100744252544E+05
0.104959398994E+05 0.109277683923E+05 0.113694846547E+05 0.118205863594E+05 0.122804905999E+05
0.127485296775E+05 0.132239471319E+05 0.137058940235E+05 0.141934255844E+05 0.146854982713E+05
0.151809673402E+05 0.156785850245E+05 0.161769993384E+05 0.166747537999E+05 0.171702877851E+05
0.176619381795E+05 0.181479417092E+05 0.186264388693E+05 0.190954787135E+05 0.195530252077E+05
0.199969649781E+05 0.204251165206E+05 0.208352408440E+05 0.212250539761E+05 0.215922406971E+05
0.219344702466E+05 0.222494132725E+05 0.225347605700E+05 0.227882431008E+05 0.230076533887E+05
0.231908681093E+05 0.233358716618E+05 0.234407805422E+05 0.235038681649E+05 0.235235900533E+05
0.234986087273E+05 0.234278183452E+05 0.233103682573E+05 0.231456854657E+05 0.229334951930E+05
0.226738393464E+05 0.223670922687E+05 0.220139733481E+05 0.216155560262E+05 0.211732727643E+05
0.206889155309E+05 0.201646315262E+05 0.196029137234E+05 0.190065861750E+05 0.183787838063E+05
0.177229268159E+05 0.170426897439E+05 0.163419655306E+05 0.156248249789E+05 0.148954722996E+05
0.141581974366E+05 0.134173260145E+05 0.126771691922E+05 0.119419712654E+05 0.112158605109E+05
0.105028006708E+05 0.980654494715E+04 0.913059233055E+04 0.847814609089E+04 0.785207437181E+04
0.725487344241E+04 0.668863511465E+04 0.615502070274E+04 0.565524418908E+04 0.519006674861E+04
0.475980360345E+04 0.436434269355E+04 0.400317323797E+04 0.367542134980E+04 0.337988976738E+04
0.311509951930E+04 0.287933230868E+04 0.267067322820E+04 0.248705367813E+04 0.232629416860E+04
0.218614663490E+04 0.206433550064E+04 0.195859682514E+04 0.186671473352E+04 0.178655448544E+04
0.171609162157E+04 0.165343661643E+04 0.159685503183E+04 0.154478263373E+04 0.149583588863E+04
0.144881771439E+04 0.140271881257E+04 0.135671510542E+04 0.131016154370E+04 0.126258277404E+04
0.121366142449E+04 0.116322423992E+04 0.111122677010E+04 0.105773711321E+04 0.100291904396E+04
0.947015115197E+03 0.890329984746E+03 0.833214293651E+03 0.776049439334E+03 0.719233318915E+03
0.663167296841E+03 0.608244410857E+03 0.554838974842E+03 0.503297365412E+03 0.453930342998E+03
0.407006607762E+03 0.362747812430E+03 0.321325009274E+03 0.282856892955E+03 0.247409239962E+03
0.214996579478E+03 0.185585236387E+03 0.159098170048E+03 0.135421626809E+03 0.114413852193E+03
0.959157052909E+02 0.797613940556E+02 0.657850483488E+02 0.538188496239E+02 0.436847852099E+02
0.351899899383E+02 0.281331189963E+02 0.223174718914E+02 0.175614959268E+02 0.137029350510E+02
0.105987314150E+02 0.812353702200E+01 0.616817828814E+01 0.463832179287E+01 0.345324799301E+01
0.254463529365E+01 0.185531917238E+01 0.133803581425E+01 0.954179117826E+00 0.672602600260E+00
0.468493246228E+00 0.322336920783E+00 0.218987948819E+00 0.146848889647E+00 0.971612490355E-01
0.634035384763E-01 0.407898120808E-01 0.258595430908E-01 0.161483043720E-01 0.992815188083E-02
0.600670032098E-02 0.357447468542E-02 0.209108518893E-02 0.120193474515E-02 0.678419162901E-03
0.375814762046E-03 0.204197625257E-03 0.108758556747E-03 0.567464770105E-04 0.289864948733E-04
0.144858436153E-04 0.707756608346E-05 0.337836787752E-05 0.157431967128E-05 0.715666075556E-06
0.317114132527E-06
mkinetic energy-density pseudized
0.246124888537E-05 0.262391872705E-05 0.279733980862E-05 0.298222270529E-05 0.317932495590E-05
0.338945416684E-05 0.361347132112E-05 0.385229430620E-05 0.410690167493E-05 0.437833665502E-05
0.466771142364E-05 0.497621166438E-05 0.530510142550E-05 0.565572829925E-05 0.602952894345E-05
0.642803496809E-05 0.685287921091E-05 0.730580242782E-05 0.778866042541E-05 0.830343166499E-05
0.885222536910E-05 0.943729016382E-05 0.100610232923E-04 0.107259804372E-04 0.114348861924E-04
0.121906452265E-04 0.129963541849E-04 0.138553143773E-04 0.147710453050E-04 0.157472990816E-04
0.167880758067E-04 0.178976399559E-04 0.190805378543E-04 0.203416163043E-04 0.216860424450E-04
0.231193249240E-04 0.246473364685E-04 0.262763379479E-04 0.280130040275E-04 0.298644505170E-04
0.318382635266E-04 0.339425305504E-04 0.361858736043E-04 0.385774845531E-04 0.411271627738E-04
0.438453553070E-04 0.467431996630E-04 0.498325694557E-04 0.531261230543E-04 0.566373554487E-04
0.603806535444E-04 0.643713551105E-04 0.686258116250E-04 0.731614552728E-04 0.779968703717E-04
0.831518695202E-04 0.886475747764E-04 0.945065042035E-04 0.100752664135E-03 0.107411647536E-03
0.114510738871E-03 0.122079025894E-03 0.130147518834E-03 0.138749277455E-03 0.147919546515E-03
0.157695900175E-03 0.168118395953E-03 0.179229738859E-03 0.191075456367E-03 0.203704084960E-03
0.217167368999E-03 0.231520472741E-03 0.246822206364E-03 0.263135266932E-03 0.280526495285E-03
0.299067149912E-03 0.318833198917E-03 0.339905631285E-03 0.362370788723E-03 0.386320719425E-03
0.411853555224E-03 0.439073913670E-03 0.468093326673E-03 0.499030697487E-03 0.532012787889E-03
0.567174737555E-03 0.604660617766E-03 0.644624021702E-03 0.687228693756E-03 0.732649200428E-03
0.781071645568E-03 0.832694432884E-03 0.887729078840E-03 0.946401079282E-03 0.100895083333E-02
0.107563462835E-02 0.114672568997E-02 0.122251530154E-02 0.130331399757E-02 0.138945283600E-02
0.148128475454E-02 0.157918601675E-02 0.168355775354E-02 0.179482760663E-02 0.191345148057E-02
0.203991541061E-02 0.217473755390E-02 0.231847031234E-02 0.247170259569E-02 0.263506223425E-02
0.280921855092E-02 0.299488510327E-02 0.319282260676E-02 0.340384205113E-02 0.362880802269E-02
0.386864224621E-02 0.412432736067E-02 0.439691094468E-02 0.468750980769E-02 0.499731456482E-02
0.532759451388E-02 0.567970283464E-02 0.605508213156E-02 0.645527034270E-02 0.688190703890E-02
0.733674013923E-02 0.782163306985E-02 0.833857239587E-02 0.888967595726E-02 0.947720154207E-02
0.101035561326E-01 0.107713057620E-01 0.114831860220E-01 0.122421132645E-01 0.130511965425E-01
0.139137503401E-01 0.148333081420E-01 0.158136368999E-01 0.168587524534E-01 0.179729359683E-01
0.191607514608E-01 0.204270644777E-01 0.217770620094E-01 0.232162737168E-01 0.247505945587E-01
0.263863089121E-01 0.281301162830E-01 0.299891587134E-01 0.319710499956E-01 0.340839068117E-01
0.363363819276E-01 0.387376995728E-01 0.412976931539E-01 0.440268454506E-01 0.469363314614E-01
0.500380640699E-01 0.533447427184E-01 0.568699052850E-01 0.606279833752E-01 0.646343612502E-01
0.689054386321E-01 0.734586976370E-01 0.783127741083E-01 0.834875336360E-01 0.890041525683E-01
0.948852043423E-01 0.101154751478E+00 0.107838443608E+00 0.114963621928E+00 0.122559430498E+00
0.130656934825E+00 0.139289248207E+00 0.148491666340E+00 0.158301810719E+00 0.168759781404E+00
0.179908319753E+00 0.191792981758E+00 0.204462322680E+00 0.217968093682E+00 0.232365451255E+00
0.247713180229E+00 0.264073931251E+00 0.281514473635E+00 0.300105964567E+00 0.319924235688E+00
0.341050098153E+00 0.363569667326E+00 0.387574708325E+00 0.413163003732E+00 0.440438744815E+00
0.469512947739E+00 0.500503896272E+00 0.533537612614E+00 0.568748358052E+00 0.606279165231E+00
0.646282403941E+00 0.688920382391E+00 0.734365986076E+00 0.782803356419E+00 0.834428611485E+00
0.889450611177E+00 0.948091769412E+00 0.101058891592E+01 0.107719421035E+01 0.114817611159E+01
0.122382040517E+01 0.130443129174E+01 0.139033253996E+01 0.148186870671E+01 0.157940642816E+01
0.168333578488E+01 0.179407174448E+01 0.191205568510E+01 0.203775700321E+01 0.217167480907E+01
0.231433971309E+01 0.246631570642E+01 0.262820213858E+01 0.280063579506E+01 0.298429307738E+01
0.317989228767E+01 0.338819601939E+01 0.361001365538E+01 0.384620397342E+01 0.409767785897E+01
0.436540112340E+01 0.465039742506E+01 0.495375128900E+01 0.527661121944E+01 0.562019289718E+01
0.598578245173E+01 0.637473979546E+01 0.678850200382E+01 0.722858672211E+01 0.769659557535E+01
0.819421755303E+01 0.872323233508E+01 0.928551351943E+01 0.988303170455E+01 0.105178573724E+02
0.111921635088E+02 0.119082278868E+02 0.126684349296E+02 0.134752770548E+02 0.143313553888E+02
0.152393797229E+02 0.162021675676E+02 0.172226421397E+02 0.183038290954E+02 0.194488518008E+02
0.206609249026E+02 0.219433459362E+02 0.232994846736E+02 0.247327698867E+02 0.262466731579E+02
0.278446893409E+02 0.295303132271E+02 0.313070119380E+02 0.331781925189E+02 0.351471641660E+02
0.372170944806E+02 0.393909591027E+02 0.416714840392E+02 0.440610799768E+02 0.465617678440E+02
0.491750948813E+02 0.519020404840E+02 0.547429111112E+02 0.576972236099E+02 0.607635763904E+02
0.639395080244E+02 0.672213430148E+02 0.706040247369E+02 0.740809358673E+02 0.776437070298E+02
0.812820149008E+02 0.849833716541E+02 0.887329083984E+02 0.925131561972E+02 0.963038293663E+02
0.100081617042E+03 0.103819990523E+03 0.107489035592E+03 0.111055320957E+03 0.114481816082E+03
0.117727873934E+03 0.120749296619E+03 0.123498504282E+03 0.125924830007E+03 0.127974965523E+03
0.129593584125E+03 0.130724168028E+03 0.131310066960E+03 0.131295812806E+03 0.130628710801E+03
0.129260720552E+03 0.127150629186E+03 0.124266503311E+03 0.120588385239E+03 0.116111171158E+03
0.110847573781E+03 0.104831028760E+03 0.981183527514E+02 0.907919018702E+02 0.829609139133E+02
0.747616492584E+02 0.663558786143E+02 0.579272084376E+02 0.496746974883E+02 0.418032150738E+02
0.345100415462E+02 0.279673372239E+02 0.223003334013E+02 0.175614569257E+02 0.137029350510E+02
0.105987314150E+02 0.812353702200E+01 0.616817828814E+01 0.463832179287E+01 0.345324799301E+01
0.254463529365E+01 0.185531917238E+01 0.133803581425E+01 0.954179117826E+00 0.672602600260E+00
0.468493246228E+00 0.322336920783E+00 0.218987948819E+00 0.146848889647E+00 0.971612490355E-01
0.634035384763E-01 0.407898120808E-01 0.258595430908E-01 0.161483043720E-01 0.992815188083E-02
0.600670032098E-02 0.357447468542E-02 0.209108518893E-02 0.120193474515E-02 0.678419162901E-03
0.375814762046E-03 0.204197625257E-03 0.108758556747E-03 0.567464770105E-04 0.289864948733E-04
0.144858436153E-04 0.707756608346E-05 0.337836787752E-05 0.157431967128E-05 0.715666075556E-06
0.317114132527E-06
local pseudopotential core
-0.170419537102E+03 -0.170420949717E+03 -0.170422317842E+03 -0.170423642879E+03 -0.170424926184E+03
-0.170426169071E+03 -0.170427372814E+03 -0.170428538644E+03 -0.170429667756E+03 -0.170430761305E+03
-0.170431820413E+03 -0.170432846163E+03 -0.170433839605E+03 -0.170434801757E+03 -0.170435733605E+03
-0.170436636101E+03 -0.170437510171E+03 -0.170438356709E+03 -0.170439176583E+03 -0.170439970631E+03
-0.170440739667E+03 -0.170441484477E+03 -0.170442205825E+03 -0.170442904450E+03 -0.170443581066E+03
-0.170444236365E+03 -0.170444871020E+03 -0.170445485679E+03 -0.170446080973E+03 -0.170446657509E+03
-0.170447215878E+03 -0.170447756653E+03 -0.170448280385E+03 -0.170448787612E+03 -0.170449278852E+03
-0.170449754608E+03 -0.170450215366E+03 -0.170450661599E+03 -0.170451093762E+03 -0.170451512298E+03
-0.170451917634E+03 -0.170452310186E+03 -0.170452690353E+03 -0.170453058526E+03 -0.170453415081E+03
-0.170453760381E+03 -0.170454094779E+03 -0.170454418618E+03 -0.170454732227E+03 -0.170455035927E+03
-0.170455330028E+03 -0.170455614830E+03 -0.170455890623E+03 -0.170456157689E+03 -0.170456416298E+03
-0.170456666716E+03 -0.170456909196E+03 -0.170457143986E+03 -0.170457371323E+03 -0.170457591439E+03
-0.170457804557E+03 -0.170458010893E+03 -0.170458210657E+03 -0.170458404049E+03 -0.170458591266E+03
-0.170458772496E+03 -0.170458947923E+03 -0.170459117722E+03 -0.170459282063E+03 -0.170459441112E+03
-0.170459595027E+03 -0.170459743963E+03 -0.170459888066E+03 -0.170460027479E+03 -0.170460162341E+03
-0.170460292785E+03 -0.170460418937E+03 -0.170460540921E+03 -0.170460658856E+03 -0.170460772854E+03
-0.170460883026E+03 -0.170460989477E+03 -0.170461092306E+03 -0.170461191611E+03 -0.170461287482E+03
-0.170461380009E+03 -0.170461469275E+03 -0.170461555360E+03 -0.170461638339E+03 -0.170461718285E+03
-0.170461795264E+03 -0.170461869342E+03 -0.170461940576E+03 -0.170462009025E+03 -0.170462074739E+03
-0.170462137766E+03 -0.170462198149E+03 -0.170462255930E+03 -0.170462311143E+03 -0.170462363820E+03
-0.170462413988E+03 -0.170462461669E+03 -0.170462506883E+03 -0.170462549643E+03 -0.170462589958E+03
-0.170462627833E+03 -0.170462663267E+03 -0.170462696254E+03 -0.170462726785E+03 -0.170462754841E+03
-0.170462780402E+03 -0.170462803439E+03 -0.170462823919E+03 -0.170462841800E+03 -0.170462857035E+03
-0.170462869571E+03 -0.170462879345E+03 -0.170462886288E+03 -0.170462890322E+03 -0.170462891361E+03
-0.170462889311E+03 -0.170462884065E+03 -0.170462875510E+03 -0.170462863519E+03 -0.170462847957E+03
-0.170462828675E+03 -0.170462805511E+03 -0.170462778292E+03 -0.170462746828E+03 -0.170462710916E+03
-0.170462670337E+03 -0.170462624855E+03 -0.170462574215E+03 -0.170462518144E+03 -0.170462456350E+03
-0.170462388516E+03 -0.170462314306E+03 -0.170462233358E+03 -0.170462145285E+03 -0.170462049670E+03
-0.170461946071E+03 -0.170461834011E+03 -0.170461712983E+03 -0.170461582443E+03 -0.170461441809E+03
-0.170461290461E+03 -0.170461127736E+03 -0.170460952924E+03 -0.170460765269E+03 -0.170460563963E+03
-0.170460348143E+03 -0.170460116887E+03 -0.170459869212E+03 -0.170459604070E+03 -0.170459320339E+03
-0.170459016825E+03 -0.170458692253E+03 -0.170458345262E+03 -0.170457974402E+03 -0.170457578124E+03
-0.170457154777E+03 -0.170456702599E+03 -0.170456219712E+03 -0.170455704112E+03 -0.170455153662E+03
-0.170454566083E+03 -0.170453938945E+03 -0.170453269655E+03 -0.170452555451E+03 -0.170451793386E+03
-0.170450980315E+03 -0.170450112890E+03 -0.170449187536E+03 -0.170448200444E+03 -0.170447147552E+03
-0.170446024529E+03 -0.170444826756E+03 -0.170443549310E+03 -0.170442186941E+03 -0.170440734052E+03
-0.170439184675E+03 -0.170437532448E+03 -0.170435770588E+03 -0.170433891862E+03 -0.170431888560E+03
-0.170429752461E+03 -0.170427474801E+03 -0.170425046235E+03 -0.170422456803E+03 -0.170419695882E+03
-0.170416752151E+03 -0.170413613538E+03 -0.170410267173E+03 -0.170406699335E+03 -0.170402895397E+03
-0.170398839763E+03 -0.170394515809E+03 -0.170389905809E+03 -0.170384990867E+03 -0.170379750838E+03
-0.170374164243E+03 -0.170368208187E+03 -0.170361858259E+03 -0.170355088435E+03 -0.170347870972E+03
-0.170340176292E+03 -0.170331972863E+03 -0.170323227069E+03 -0.170313903070E+03 -0.170303962662E+03
-0.170293365112E+03 -0.170282066997E+03 -0.170270022024E+03 -0.170257180840E+03 -0.170243490832E+03
-0.170228895910E+03 -0.170213336276E+03 -0.170196748182E+03 -0.170179063668E+03 -0.170160210283E+03
-0.170140110788E+03 -0.170118682843E+03 -0.170095838665E+03 -0.170071484675E+03 -0.170045521109E+03
-0.170017841614E+03 -0.169988332811E+03 -0.169956873833E+03 -0.169923335828E+03 -0.169887581435E+03
-0.169849464223E+03 -0.169808828091E+03 -0.169765506630E+03 -0.169719322446E+03 -0.169670086435E+03
-0.169617597009E+03 -0.169561639280E+03 -0.169501984178E+03 -0.169438387525E+03 -0.169370589035E+03
-0.169298311258E+03 -0.169221258457E+03 -0.169139115401E+03 -0.169051546092E+03 -0.168958192406E+03
-0.168858672641E+03 -0.168752579981E+03 -0.168639480855E+03 -0.168518913198E+03 -0.168390384594E+03
-0.168253370309E+03 -0.168107311204E+03 -0.167951611505E+03 -0.167785636454E+03 -0.167608709804E+03
-0.167420111171E+03 -0.167219073226E+03 -0.167004778724E+03 -0.166776357364E+03 -0.166532882470E+03
-0.166273367495E+03 -0.165996762340E+03 -0.165701949473E+03 -0.165387739872E+03 -0.165052868771E+03
-0.164695991214E+03 -0.164315677437E+03 -0.163910408071E+03 -0.163478569188E+03 -0.163018447220E+03
-0.162528223759E+03 -0.162005970291E+03 -0.161449642903E+03 -0.160857077032E+03 -0.160225982313E+03
-0.159553937637E+03 -0.158838386520E+03 -0.158076632925E+03 -0.157265837697E+03 -0.156403015813E+03
-0.155485034673E+03 -0.154508613712E+03 -0.153470325644E+03 -0.152366599705E+03 -0.151193727316E+03
-0.149947870610E+03 -0.148625074366E+03 -0.147221281861E+03 -0.145732355265E+03 -0.144154101132E+03
-0.142482301607E+03 -0.140712751934E+03 -0.138841304820E+03 -0.136863922328E+03 -0.134776736105E+03
-0.132576117318E+03 -0.130258758637E+03 -0.127821772487E+03 -0.125262812538E+03 -0.122580229059E+03
-0.119773271760E+03 -0.116842352862E+03 -0.113789370936E+03 -0.110618060917E+03 -0.107334264143E+03
-0.103945902820E+03 -0.100462343388E+03 -0.968929062687E+02 -0.932448542294E+02 -0.895225733479E+02
-0.857313037065E+02 -0.818880617199E+02 -0.780358333759E+02 -0.742473243088E+02 -0.706440350099E+02
-0.673676290197E+02 -0.644619319781E+02 -0.619683360442E+02 -0.599284345816E+02 -0.583796623680E+02
-0.573483530309E+02 -0.564049902626E+02 -0.546210802335E+02 -0.528996689676E+02 -0.512328440922E+02
-0.496187824367E+02 -0.480557353139E+02 -0.465420447751E+02 -0.450761138085E+02 -0.436564113209E+02
-0.422814579106E+02 -0.409498296230E+02 -0.396601648757E+02 -0.384111132984E+02 -0.372014105719E+02
-0.360298090009E+02 -0.348951073700E+02 -0.337961428427E+02 -0.327317889712E+02 -0.317009553098E+02
-0.307025861793E+02 -0.297356589850E+02 -0.287991834979E+02 -0.278922006685E+02 -0.270137815368E+02
-0.261630366058E+02 -0.253390651934E+02 -0.245410526913E+02 -0.237681721638E+02 -0.230196321567E+02
-0.222946661137E+02
pspotential valence only
-0.284683254939E+02 -0.284697381271E+02 -0.284711062722E+02 -0.284724313301E+02 -0.284737146577E+02
-0.284749575687E+02 -0.284761613369E+02 -0.284773271946E+02 -0.284784563356E+02 -0.284795499162E+02
-0.284806090569E+02 -0.284816348417E+02 -0.284826283219E+02 -0.284835905140E+02 -0.284845224041E+02
-0.284854249463E+02 -0.284862990646E+02 -0.284871456545E+02 -0.284879655834E+02 -0.284887596902E+02
-0.284895287887E+02 -0.284902736661E+02 -0.284909950857E+02 -0.284916937861E+02 -0.284923704830E+02
-0.284930258689E+02 -0.284936606159E+02 -0.284942753734E+02 -0.284948707712E+02 -0.284954474190E+02
-0.284960059074E+02 -0.284965468085E+02 -0.284970706761E+02 -0.284975780470E+02 -0.284980694407E+02
-0.284985453605E+02 -0.284990062936E+02 -0.284994527124E+02 -0.284998850740E+02 -0.285003038213E+02
-0.285007093833E+02 -0.285011021753E+02 -0.285014825995E+02 -0.285018510457E+02 -0.285022078914E+02
-0.285025535021E+02 -0.285028882318E+02 -0.285032124235E+02 -0.285035264093E+02 -0.285038305108E+02
-0.285041250397E+02 -0.285044102975E+02 -0.285046865768E+02 -0.285049541606E+02 -0.285052133230E+02
-0.285054643298E+02 -0.285057074382E+02 -0.285059428973E+02 -0.285061709484E+02 -0.285063918256E+02
-0.285066057551E+02 -0.285068129563E+02 -0.285070136418E+02 -0.285072080174E+02 -0.285073962824E+02
-0.285075786302E+02 -0.285077552478E+02 -0.285079263164E+02 -0.285080920118E+02 -0.285082525042E+02
-0.285084079583E+02 -0.285085585338E+02 -0.285087043857E+02 -0.285088456639E+02 -0.285089825138E+02
-0.285091150761E+02 -0.285092434873E+02 -0.285093678798E+02 -0.285094883820E+02 -0.285096051179E+02
-0.285097182082E+02 -0.285098277696E+02 -0.285099339157E+02 -0.285100367561E+02 -0.285101363974E+02
-0.285102329431E+02 -0.285103264934E+02 -0.285104171457E+02 -0.285105049943E+02 -0.285105901311E+02
-0.285106726449E+02 -0.285107526223E+02 -0.285108301473E+02 -0.285109053014E+02 -0.285109781641E+02
-0.285110488125E+02 -0.285111173215E+02 -0.285111837644E+02 -0.285112482121E+02 -0.285113107339E+02
-0.285113713974E+02 -0.285114302684E+02 -0.285114874111E+02 -0.285115428883E+02 -0.285115967613E+02
-0.285116490901E+02 -0.285116999333E+02 -0.285117493486E+02 -0.285117973923E+02 -0.285118441197E+02
-0.285118895855E+02 -0.285119338432E+02 -0.285119769456E+02 -0.285120189449E+02 -0.285120598926E+02
-0.285120998398E+02 -0.285121388371E+02 -0.285121769347E+02 -0.285122141827E+02 -0.285122506311E+02
-0.285122863296E+02 -0.285123213283E+02 -0.285123556771E+02 -0.285123894265E+02 -0.285124226271E+02
-0.285124553304E+02 -0.285124875881E+02 -0.285125194530E+02 -0.285125509785E+02 -0.285125822193E+02
-0.285126132311E+02 -0.285126440711E+02 -0.285126747978E+02 -0.285127054715E+02 -0.285127361543E+02
-0.285127669105E+02 -0.285127978063E+02 -0.285128289107E+02 -0.285128602951E+02 -0.285128920341E+02
-0.285129242051E+02 -0.285129568892E+02 -0.285129901712E+02 -0.285130241396E+02 -0.285130588877E+02
-0.285130945129E+02 -0.285131311181E+02 -0.285131688112E+02 -0.285132077060E+02 -0.285132479227E+02
-0.285132895879E+02 -0.285133328354E+02 -0.285133778067E+02 -0.285134246515E+02 -0.285134735280E+02
-0.285135246042E+02 -0.285135780579E+02 -0.285136340776E+02 -0.285136928634E+02 -0.285137546275E+02
-0.285138195953E+02 -0.285138880062E+02 -0.285139601145E+02 -0.285140361905E+02 -0.285141165216E+02
-0.285142014133E+02 -0.285142911905E+02 -0.285143861989E+02 -0.285144868063E+02 -0.285145934040E+02
-0.285147064088E+02 -0.285148262640E+02 -0.285149534418E+02 -0.285150884449E+02 -0.285152318086E+02
-0.285153841030E+02 -0.285155459353E+02 -0.285157179524E+02 -0.285159008433E+02 -0.285160953418E+02
-0.285163022301E+02 -0.285165223414E+02 -0.285167565633E+02 -0.285170058417E+02 -0.285172711848E+02
-0.285175536665E+02 -0.285178544315E+02 -0.285181746997E+02 -0.285185157709E+02 -0.285188790308E+02
-0.285192659558E+02 -0.285196781195E+02 -0.285201171993E+02 -0.285205849827E+02 -0.285210833750E+02
-0.285216144068E+02 -0.285221802425E+02 -0.285227831889E+02 -0.285234257049E+02 -0.285241104112E+02
-0.285248401009E+02 -0.285256177512E+02 -0.285264465355E+02 -0.285273298358E+02 -0.285282712570E+02
-0.285292746413E+02 -0.285303440839E+02 -0.285314839493E+02 -0.285326988895E+02 -0.285339938624E+02
-0.285353741521E+02 -0.285368453903E+02 -0.285384135789E+02 -0.285400851146E+02 -0.285418668143E+02
-0.285437659428E+02 -0.285457902421E+02 -0.285479479626E+02 -0.285502478960E+02 -0.285526994109E+02
-0.285553124903E+02 -0.285580977715E+02 -0.285610665889E+02 -0.285642310189E+02 -0.285676039282E+02
-0.285711990254E+02 -0.285750309147E+02 -0.285791151548E+02 -0.285834683196E+02 -0.285881080644E+02
-0.285930531950E+02 -0.285983237421E+02 -0.286039410397E+02 -0.286099278085E+02 -0.286163082449E+02
-0.286231081153E+02 -0.286303548557E+02 -0.286380776784E+02 -0.286463076848E+02 -0.286550779846E+02
-0.286644238234E+02 -0.286743827172E+02 -0.286849945954E+02 -0.286963019524E+02 -0.287083500084E+02
-0.287211868802E+02 -0.287348637617E+02 -0.287494351160E+02 -0.287649588782E+02 -0.287814966715E+02
-0.287991140354E+02 -0.288178806686E+02 -0.288378706855E+02 -0.288591628897E+02 -0.288818410637E+02
-0.289059942762E+02 -0.289317172092E+02 -0.289591105063E+02 -0.289882811421E+02 -0.290193428172E+02
-0.290524163789E+02 -0.290876302704E+02 -0.291251210119E+02 -0.291650337155E+02 -0.292075226382E+02
-0.292527517763E+02 -0.293008955057E+02 -0.293521392725E+02 -0.294066803402E+02 -0.294647285981E+02
-0.295265074381E+02 -0.295922547054E+02 -0.296622237316E+02 -0.297366844547E+02 -0.298159246331E+02
-0.299002511574E+02 -0.299899914619E+02 -0.300854950331E+02 -0.301871350062E+02 -0.302953098315E+02
-0.304104449766E+02 -0.305329946137E+02 -0.306634432095E+02 -0.308023068980E+02 -0.309501344631E+02
-0.311075076831E+02 -0.312750406914E+02 -0.314533778800E+02 -0.316431897005E+02 -0.318451655059E+02
-0.320600023150E+02 -0.322883880770E+02 -0.325309776931E+02 -0.327883597634E+02 -0.330610118773E+02
-0.333492424278E+02 -0.336531176630E+02 -0.339723743103E+02 -0.343063208921E+02 -0.346537346687E+02
-0.350127648590E+02 -0.353808530483E+02 -0.357546715064E+02 -0.361300480027E+02 -0.365017784125E+02
-0.368631247339E+02 -0.372047035859E+02 -0.375125522453E+02 -0.377657441997E+02 -0.379353184151E+02
-0.379879389853E+02 -0.378969925173E+02 -0.376572676136E+02 -0.372895576797E+02 -0.368609888139E+02
-0.364580391316E+02 -0.360705398812E+02 -0.356893344048E+02 -0.353112759769E+02 -0.349371692593E+02
-0.345669009289E+02 -0.341257389052E+02 -0.337108267652E+02 -0.332925072698E+02 -0.328642387355E+02
-0.324255741088E+02 -0.319762374261E+02 -0.315162189773E+02 -0.310457677673E+02 -0.305653859428E+02
-0.300757994671E+02 -0.295778859655E+02 -0.290726427811E+02 -0.285611001088E+02 -0.280442533230E+02
-0.275230192225E+02 -0.269981679715E+02 -0.264702980396E+02 -0.259398216884E+02 -0.254069826533E+02
-0.248718994035E+02 -0.243346314120E+02 -0.237952586509E+02 -0.232539624826E+02 -0.227110955590E+02
-0.221672327097E+02 -0.216231877485E+02 -0.210800244667E+02 -0.205390174919E+02 -0.200016158604E+02
-0.194693867508E+02
core charge-density (pseudized)
0.158850899689E-07 0.169349736624E-07 0.180542466866E-07 0.192474951488E-07 0.205196082630E-07
0.218757983829E-07 0.233216223594E-07 0.248630043089E-07 0.265062598867E-07 0.282581221651E-07
0.301257692211E-07 0.321168535480E-07 0.342395334107E-07 0.365025062734E-07 0.389150444365E-07
0.414870330287E-07 0.442290105108E-07 0.471522118554E-07 0.502686145814E-07 0.535909878306E-07
0.571329446878E-07 0.609089979589E-07 0.649346196361E-07 0.692263042922E-07 0.738016366658E-07
0.786793637127E-07 0.838794714198E-07 0.894232666954E-07 0.953334646720E-07 0.101634281779E-06
0.108351534969E-06 0.115512747495E-06 0.123147261690E-06 0.131286359191E-06 0.139963389111E-06
0.149213904686E-06 0.159075808951E-06 0.169589510039E-06 0.180798086755E-06 0.192747465083E-06
0.205486606363E-06 0.219067707906E-06 0.233546416867E-06 0.248982058249E-06 0.265437877988E-06
0.282981302089E-06 0.301684212902E-06 0.321623243648E-06 0.342880092415E-06 0.365541856912E-06
0.389701391334E-06 0.415457686827E-06 0.442916277090E-06 0.472189670789E-06 0.503397812546E-06
0.536668574398E-06 0.572138279738E-06 0.609952261885E-06 0.650265459564E-06 0.693243051754E-06
0.739061134484E-06 0.787907442368E-06 0.839982117817E-06 0.895498531103E-06 0.954684154611E-06
0.101778149488E-05 0.108504908622E-05 0.115676255007E-05 0.123321572426E-05 0.131472186699E-05
0.140161494038E-05 0.149425097881E-05 0.159300954771E-05 0.169829529876E-05 0.181053962793E-05
0.193020244302E-05 0.205777404804E-05 0.219377715217E-05 0.233876901146E-05 0.249334371211E-05
0.265813460454E-05 0.283381689853E-05 0.302111042968E-05 0.322078260881E-05 0.343365156625E-05
0.366058950397E-05 0.390252626918E-05 0.416045316422E-05 0.443542700810E-05 0.472857446660E-05
0.504109666844E-05 0.537427412660E-05 0.572947198482E-05 0.610814561085E-05 0.651184655941E-05
0.694222892908E-05 0.740105613948E-05 0.789020815618E-05 0.841168919314E-05 0.896763592422E-05
0.956032623723E-05 0.101921885666E-04 0.108658118429E-04 0.115839560993E-04 0.123495637799E-04
0.131657717945E-04 0.140359243703E-04 0.149635867530E-04 0.159525598129E-04 0.170068956168E-04
0.181309140281E-04 0.193292204042E-04 0.206067244636E-04 0.219686603991E-04 0.234206083207E-04
0.249685171141E-04 0.266187288110E-04 0.283780045687E-04 0.302535523666E-04 0.322530565318E-04
0.343847092167E-04 0.366572439552E-04 0.390799714357E-04 0.416628176384E-04 0.444163644905E-04
0.473518932085E-04 0.504814305022E-04 0.538177978316E-04 0.573746639168E-04 0.611666007161E-04
0.652091431015E-04 0.695188524752E-04 0.741133845867E-04 0.790115618292E-04 0.842334503093E-04
0.898004420053E-04 0.957353423503E-04 0.102062463597E-03 0.108807724347E-03 0.115998755648E-03
0.123665014094E-03 0.131837902394E-03 0.140550897889E-03 0.149839689558E-03 0.159742324059E-03
0.170299361400E-03 0.181554040889E-03 0.193552458017E-03 0.206343753015E-03 0.219980311839E-03
0.234517980402E-03 0.250016292931E-03 0.266538715372E-03 0.284152904832E-03 0.302930986106E-03
0.322949846427E-03 0.344291449616E-03 0.367043170908E-03 0.391298153825E-03 0.417155690514E-03
0.444721627115E-03 0.474108795766E-03 0.505437475018E-03 0.538835880487E-03 0.574440687740E-03
0.612397589507E-03 0.652861889451E-03 0.695999134887E-03 0.741985790982E-03 0.791009959124E-03
0.843272142330E-03 0.898986060746E-03 0.958379520474E-03 0.102169533918E-02 0.108919233216E-02
0.116114636271E-02 0.123785146100E-02 0.131962101582E-02 0.140678904387E-02 0.149971154154E-02
0.159876792447E-02 0.170436256045E-02 0.181692640162E-02 0.193691872220E-02 0.206482896848E-02
0.220117872808E-02 0.234652382591E-02 0.250145655494E-02 0.266660804989E-02 0.284265081290E-02
0.303030140045E-02 0.323032328145E-02 0.344352987696E-02 0.367078779245E-02 0.391302025435E-02
0.417121076298E-02 0.444640697483E-02 0.473972482752E-02 0.505235292185E-02 0.538555717557E-02
0.574068576454E-02 0.611917436752E-02 0.652255173154E-02 0.695244557544E-02 0.741058885008E-02
0.789882637401E-02 0.841912186447E-02 0.897356538393E-02 0.956438122282E-02 0.101939362401E-01
0.108647486828E-01 0.115794975075E-01 0.123410322246E-01 0.131523832881E-01 0.140167730542E-01
0.149376273269E-01 0.159185875152E-01 0.169635234187E-01 0.180765466621E-01 0.192620247931E-01
0.205245960596E-01 0.218691848759E-01 0.233010179867E-01 0.248256413302E-01 0.264489375990E-01
0.281771444893E-01 0.300168736216E-01 0.319751301066E-01 0.340593327208E-01 0.362773346404E-01
0.386374446716E-01 0.411484488953E-01 0.438196326246E-01 0.466608025533E-01 0.496823089450E-01
0.528950676826E-01 0.563105819652E-01 0.599409633995E-01 0.637989521880E-01 0.678979360665E-01
0.722519675861E-01 0.768757792715E-01 0.817847961130E-01 0.869951447703E-01 0.925236587738E-01
0.983878789095E-01 0.104606047856E+00 0.111197098026E+00 0.118180631410E+00 0.125576890089E+00
0.133406715896E+00 0.141691497534E+00 0.150453103263E+00 0.159713797041E+00 0.169496135792E+00
0.179822845227E+00 0.190716671374E+00 0.202200204726E+00 0.214295673644E+00 0.227024703349E+00
0.240408036607E+00 0.254465211927E+00 0.269214194858E+00 0.284670957798E+00 0.300849003557E+00
0.317758827869E+00 0.335407316081E+00 0.353797069410E+00 0.372925656495E+00 0.392784786538E+00
0.413359401140E+00 0.434626683071E+00 0.456554981802E+00 0.479102657604E+00 0.502216848651E+00
0.525832168810E+00 0.549869347839E+00 0.574233830650E+00 0.598814358233E+00 0.623481559867E+00
0.648086594575E+00 0.672459889336E+00 0.696410032536E+00 0.719722893489E+00 0.742161052417E+00
0.763463640029E+00 0.783346701288E+00 0.801504213699E+00 0.817609905660E+00 0.831320034071E+00
0.842277290994E+00 0.850116014825E+00 0.854468879722E+00 0.854975224885E+00 0.851291158898E+00
0.843101529429E+00 0.830133779791E+00 0.812173615663E+00 0.789082271343E+00 0.760814989247E+00
0.727440103218E+00 0.689157841522E+00 0.646317637620E+00 0.599432358703E+00 0.549187442962E+00
0.496442495144E+00 0.442222457189E+00 0.387695093883E+00 0.334131279817E+00 0.282844534494E+00
0.235106544671E+00 0.192036181160E+00 0.154460929685E+00 0.122751894914E+00 0.966509407173E-01
0.754197350591E-01 0.583105682925E-01 0.446553131657E-01 0.338641471811E-01 0.254227490621E-01
0.188882113068E-01 0.138839137385E-01 0.100936590292E-01 0.725537509450E-02 0.515466309716E-02
0.361842930266E-02 0.250879268147E-02 0.171741309607E-02 0.116033964584E-02 0.773437417305E-03
0.508414784907E-03 0.329443540380E-03 0.210340978410E-03 0.132266603092E-03 0.818759218551E-04
0.498690344207E-04 0.298714443437E-04 0.175875916060E-04 0.101729842592E-04 0.577752330293E-05
0.321986957660E-05 0.175987680434E-05 0.942778890139E-06 0.494707936977E-06 0.254108048780E-06
0.127681574306E-06 0.627159654587E-07 0.300924318689E-07 0.140943050873E-07 0.643877401768E-08
0.286674509825E-08
pseudo wavefunction
0.575355347414E-04 0.594064467959E-04 0.613381962429E-04 0.633327613625E-04 0.653921847638E-04
0.675185754763E-04 0.697141111098E-04 0.719810400846E-04 0.743216839340E-04 0.767384396819E-04
0.792337822973E-04 0.818102672291E-04 0.844705330228E-04 0.872173040230E-04 0.900533931633E-04
0.929817048467E-04 0.960052379201E-04 0.991270887455E-04 0.102350454371E-03 0.105678635804E-03
0.109115041394E-03 0.112663190320E-03 0.116326716196E-03 0.120109370793E-03 0.124015027879E-03
0.128047687189E-03 0.132211478517E-03 0.136510665951E-03 0.140949652232E-03 0.145532983271E-03
0.150265352799E-03 0.155151607175E-03 0.160196750351E-03 0.165405948993E-03 0.170784537776E-03
0.176338024845E-03 0.182072097454E-03 0.187992627794E-03 0.194105679006E-03 0.200417511387E-03
0.206934588804E-03 0.213663585314E-03 0.220611391995E-03 0.227785124008E-03 0.235192127880E-03
0.242839989029E-03 0.250736539531E-03 0.258889866144E-03 0.267308318583E-03 0.276000518079E-03
0.284975366201E-03 0.294242053974E-03 0.303810071296E-03 0.313689216649E-03 0.323889607138E-03
0.334421688850E-03 0.345296247555E-03 0.356524419746E-03 0.368117704048E-03 0.380087972993E-03
0.392447485177E-03 0.405208897814E-03 0.418385279700E-03 0.431990124593E-03 0.446037365035E-03
0.460541386620E-03 0.475517042723E-03 0.490979669714E-03 0.506945102664E-03 0.523429691556E-03
0.540450318037E-03 0.558024412700E-03 0.576169972936E-03 0.594905581365E-03 0.614250424868E-03
0.634224314231E-03 0.654847704436E-03 0.676141715611E-03 0.698128154653E-03 0.720829537562E-03
0.744269112502E-03 0.768470883604E-03 0.793459635553E-03 0.819260958964E-03 0.845901276593E-03
0.873407870393E-03 0.901808909454E-03 0.931133478849E-03 0.961411609419E-03 0.992674308528E-03
0.102495359182E-02 0.105828251598E-02 0.109269521264E-02 0.112822692327E-02 0.116491403530E-02
0.120279411939E-02 0.124190596788E-02 0.128228963454E-02 0.132398647555E-02 0.136703919190E-02
0.141149187307E-02 0.145739004223E-02 0.150478070279E-02 0.155371238660E-02 0.160423520360E-02
0.165640089318E-02 0.171026287709E-02 0.176587631424E-02 0.182329815708E-02 0.188258721000E-02
0.194380418952E-02 0.200701178645E-02 0.207227473008E-02 0.213965985449E-02 0.220923616697E-02
0.228107491867E-02 0.235524967759E-02 0.243183640385E-02 0.251091352754E-02 0.259256202897E-02
0.267686552162E-02 0.276391033773E-02 0.285378561671E-02 0.294658339640E-02 0.304239870730E-02
0.314132966987E-02 0.324347759500E-02 0.334894708771E-02 0.345784615425E-02 0.357028631269E-02
0.368638270708E-02 0.380625422530E-02 0.393002362081E-02 0.405781763827E-02 0.418976714331E-02
0.432600725647E-02 0.446667749152E-02 0.461192189824E-02 0.476188920988E-02 0.491673299540E-02
0.507661181657E-02 0.524168939035E-02 0.541213475631E-02 0.558812244973E-02 0.576983268009E-02
0.595745151554E-02 0.615117107322E-02 0.635118971583E-02 0.655771225459E-02 0.677095015869E-02
0.699112177165E-02 0.721845253461E-02 0.745317521688E-02 0.769553015401E-02 0.794576549352E-02
0.820413744857E-02 0.847091055996E-02 0.874635796647E-02 0.903076168407E-02 0.932441289409E-02
0.962761224075E-02 0.994067013832E-02 0.102639070882E-01 0.105976540061E-01 0.109422525603E-01
0.112980555200E-01 0.116654271158E-01 0.120447434111E-01 0.124363926859E-01 0.128407758327E-01
0.132583067657E-01 0.136894128422E-01 0.141345352983E-01 0.145941296989E-01 0.150686664009E-01
0.155586310324E-01 0.160645249872E-01 0.165868659342E-01 0.171261883444E-01 0.176830440334E-01
0.182580027226E-01 0.188516526171E-01 0.194646010028E-01 0.200974748619E-01 0.207509215086E-01
0.214256092443E-01 0.221222280340E-01 0.228414902039E-01 0.235841311607E-01 0.243509101343E-01
0.251426109430E-01 0.259600427831E-01 0.268040410429E-01 0.276754681426E-01 0.285752143996E-01
0.295041989207E-01 0.304633705225E-01 0.314537086791E-01 0.324762244998E-01 0.335319617355E-01
0.346219978170E-01 0.357474449230E-01 0.369094510819E-01 0.381092013054E-01 0.393479187556E-01
0.406268659478E-01 0.419473459869E-01 0.433107038408E-01 0.447183276504E-01 0.461716500761E-01
0.476721496838E-01 0.492213523683E-01 0.508208328170E-01 0.524722160129E-01 0.541771787786E-01
0.559374513607E-01 0.577548190562E-01 0.596311238795E-01 0.615682662727E-01 0.635682068564E-01
0.656329682232E-01 0.677646367731E-01 0.699653645899E-01 0.722373713589E-01 0.745829463247E-01
0.770044502882E-01 0.795043176423E-01 0.820850584435E-01 0.847492605189E-01 0.874995916053E-01
0.903388015194E-01 0.932697243532E-01 0.962952806953E-01 0.994184798691E-01 0.102642422187E+00
0.105970301215E+00 0.109405406033E+00 0.112951123506E+00 0.116610940521E+00 0.120388446224E+00
0.124287334210E+00 0.128311404677E+00 0.132464566515E+00 0.136750839334E+00 0.141174355391E+00
0.145739361417E+00 0.150450220313E+00 0.155311412692E+00 0.160327538239E+00 0.165503316871E+00
0.170843589644E+00 0.176353319387E+00 0.182037591014E+00 0.187901611466E+00 0.193950709243E+00
0.200190333447E+00 0.206626052301E+00 0.213263551044E+00 0.220108629141E+00 0.227167196717E+00
0.234445270112E+00 0.241948966447E+00 0.249684497087E+00 0.257658159858E+00 0.265876329868E+00
0.274345448775E+00 0.283072012294E+00 0.292062555759E+00 0.301323637496E+00 0.310861819756E+00
0.320683646913E+00 0.330795620636E+00 0.341204171652E+00 0.351915627735E+00 0.362936177473E+00
0.374271829350E+00 0.385928365590E+00 0.397911290193E+00 0.410225770506E+00 0.422876571603E+00
0.435867982691E+00 0.449203734658E+00 0.462886907800E+00 0.476919828678E+00 0.491303954927E+00
0.506039746769E+00 0.521126523834E+00 0.536562305798E+00 0.552343635204E+00 0.568465380740E+00
0.584920519078E+00 0.601699893320E+00 0.618791945934E+00 0.636182424019E+00 0.653854054636E+00
0.671786187949E+00 0.689954405900E+00 0.708330094256E+00 0.726879976015E+00 0.745565604418E+00
0.764342814255E+00 0.783161130667E+00 0.801963135452E+00 0.820683791893E+00 0.839249730401E+00
0.857578498949E+00 0.875577784285E+00 0.893144612430E+00 0.910164539979E+00 0.926510851286E+00
0.942043780836E+00 0.956609784897E+00 0.970040892017E+00 0.982154168004E+00 0.992751337569E+00
0.100161861173E+01 0.100852677707E+01 0.101323160973E+01 0.101547468295E+01 0.101498464155E+01
0.101147901924E+01 0.100466111497E+01 0.994375950448E+00 0.980707901591E+00 0.963803639329E+00
0.943836461172E+00 0.921004116597E+00 0.895526241359E+00 0.867641520215E+00 0.837604615000E+00
0.805682938619E+00 0.772153342384E+00 0.737298744582E+00 0.701404760904E+00 0.664756390336E+00
0.627634741711E+00 0.590313873286E+00 0.553057756365E+00 0.516117401327E+00 0.479728188657E+00
0.444107456577E+00 0.409452404308E+00 0.375938372688E+00 0.343717559055E+00 0.312918210115E+00
0.283644316716E+00 0.255975805584E+00 0.229969207138E+00 0.205658740221E+00 0.183057753088E+00
0.162160440109E+00
ae wavefunction
0.723210491956E-03 0.746578583770E-03 0.770700951993E-03 0.795601892227E-03 0.821306479369E-03
0.847840592488E-03 0.875230940375E-03 0.903505087772E-03 0.932691482807E-03 0.962819484716E-03
0.993919392949E-03 0.102602247680E-02 0.105916100625E-02 0.109336828344E-02 0.112867867548E-02
0.116512764795E-02 0.120275179956E-02 0.124158889799E-02 0.128167791659E-02 0.132305907237E-02
0.136577386512E-02 0.140986511768E-02 0.145537701746E-02 0.150235515925E-02 0.155084658925E-02
0.160089985052E-02 0.165256502971E-02 0.170589380529E-02 0.176093949712E-02 0.181775711760E-02
0.187640342429E-02 0.193693697409E-02 0.199941817908E-02 0.206390936390E-02 0.213047482499E-02
0.219918089139E-02 0.227009598742E-02 0.234329069717E-02 0.241883783086E-02 0.249681249307E-02
0.257729215303E-02 0.266035671683E-02 0.274608860172E-02 0.283457281255E-02 0.292589702034E-02
0.302015164303E-02 0.311742992854E-02 0.321782804011E-02 0.332144514397E-02 0.342838349946E-02
0.353874855160E-02 0.365264902612E-02 0.377019702712E-02 0.389150813722E-02 0.401670152049E-02
0.414590002798E-02 0.427923030608E-02 0.441682290755E-02 0.455881240553E-02 0.470533751028E-02
0.485654118900E-02 0.501257078845E-02 0.517357816061E-02 0.533971979149E-02 0.551115693279E-02
0.568805573680E-02 0.587058739433E-02 0.605892827584E-02 0.625326007563E-02 0.645376995923E-02
0.666065071397E-02 0.687410090265E-02 0.709432502044E-02 0.732153365478E-02 0.755594364866E-02
0.779777826652E-02 0.804726736390E-02 0.830464755909E-02 0.857016240900E-02 0.884406258640E-02
0.912660606132E-02 0.941805828423E-02 0.971869237195E-02 0.100287892964E-01 0.103486380750E-01
0.106785359635E-01 0.110187886512E-01 0.113697104566E-01 0.117316245259E-01 0.121048630323E-01
0.124897673751E-01 0.128866883819E-01 0.132959865080E-01 0.137180320384E-01 0.141532052878E-01
0.146018967997E-01 0.150645075448E-01 0.155414491166E-01 0.160331439246E-01 0.165400253848E-01
0.170625381058E-01 0.176011380701E-01 0.181562928105E-01 0.187284815799E-01 0.193181955137E-01
0.199259377844E-01 0.205522237464E-01 0.211975810705E-01 0.218625498668E-01 0.225476827944E-01
0.232535451563E-01 0.239807149791E-01 0.247297830737E-01 0.255013530778E-01 0.262960414763E-01
0.271144775983E-01 0.279573035892E-01 0.288251743544E-01 0.297187574729E-01 0.306387330781E-01
0.315857937031E-01 0.325606440870E-01 0.335640009402E-01 0.345965926640E-01 0.356591590220E-01
0.367524507593E-01 0.378772291652E-01 0.390342655757E-01 0.402243408110E-01 0.414482445436E-01
0.427067745919E-01 0.440007361337E-01 0.453309408352E-01 0.466982058883E-01 0.481033529513E-01
0.495472069857E-01 0.510305949826E-01 0.525543445725E-01 0.541192825097E-01 0.557262330238E-01
0.573760160317E-01 0.590694451993E-01 0.608073258461E-01 0.625904526816E-01 0.644196073662E-01
0.662955558838E-01 0.682190457186E-01 0.701908028232E-01 0.722115283678E-01 0.742818952600E-01
0.764025444212E-01 0.785740808093E-01 0.807970691759E-01 0.830720295419E-01 0.853994323839E-01
0.877796935126E-01 0.902131686350E-01 0.927001475833E-01 0.952408481994E-01 0.978354098603E-01
0.100483886632E+00 0.103186240036E+00 0.105942331426E+00 0.108751913939E+00 0.111614624041E+00
0.114529972627E+00 0.117497335686E+00 0.120515944498E+00 0.123584875391E+00 0.126703039005E+00
0.129869169099E+00 0.133081810868E+00 0.136339308790E+00 0.139639793985E+00 0.142981171101E+00
0.146361104728E+00 0.149777005361E+00 0.153226014901E+00 0.156704991737E+00 0.160210495417E+00
0.163738770941E+00 0.167285732697E+00 0.170846948100E+00 0.174417620953E+00 0.177992574602E+00
0.181566234937E+00 0.185132613303E+00 0.188685289405E+00 0.192217394292E+00 0.195721593504E+00
0.199190070517E+00 0.202614510568E+00 0.205986085027E+00 0.209295436430E+00 0.212532664351E+00
0.215687312275E+00 0.218748355654E+00 0.221704191362E+00 0.224542628748E+00 0.227250882534E+00
0.229815567796E+00 0.232222697309E+00 0.234457681522E+00 0.236505331475E+00 0.238349864969E+00
0.239974916327E+00 0.241363550084E+00 0.242498278978E+00 0.243361086622E+00 0.243933455227E+00
0.244196398801E+00 0.244130502213E+00 0.243715966544E+00 0.242932661134E+00 0.241760182755E+00
0.240177922301E+00 0.238165139411E+00 0.235701045406E+00 0.232764894903E+00 0.229336086443E+00
0.225394272444E+00 0.220919478726E+00 0.215892233821E+00 0.210293708226E+00 0.204105863651E+00
0.197311612280E+00 0.189894985941E+00 0.181841314980E+00 0.173137416545E+00 0.163771791829E+00
0.153734831728E+00 0.143019030191E+00 0.131619204408E+00 0.119532720834E+00 0.106759725824E+00
0.933033795277E-01 0.791700914244E-01 0.643697556857E-01 0.489159842511E-01 0.328263352024E-01
0.161225336665E-01 -0.116931789868E-02 -0.190185435298E-01 -0.373897154028E-01 -0.562424969619E-01
-0.755315106483E-01 -0.952062321565E-01 -0.115210911281E+00 -0.135484517197E+00 -0.155960704264E+00
-0.176567794242E+00 -0.197228773280E+00 -0.217861307379E+00 -0.238377787431E+00 -0.258685422148E+00
-0.278686401205E+00 -0.298278148790E+00 -0.317353678585E+00 -0.335802047802E+00 -0.353508896551E+00
-0.370357054796E+00 -0.386227202908E+00 -0.400998578759E+00 -0.414549729935E+00 -0.426759311736E+00
-0.437506930652E+00 -0.446674029444E+00 -0.454144808540E+00 -0.459807175066E+00 -0.463553710585E+00
-0.465282647871E+00 -0.464898847424E+00 -0.462314764450E+00 -0.457451398192E+00 -0.450239215408E+00
-0.440619040450E+00 -0.428542905017E+00 -0.413974850508E+00 -0.396891676564E+00 -0.377283628995E+00
-0.355155020605E+00 -0.330524777997E+00 -0.303426906672E+00 -0.273910866599E+00 -0.242041849499E+00
-0.207900947753E+00 -0.171585205060E+00 -0.133207537940E+00 -0.928965176587E-01 -0.507960038343E-01
-0.706462318874E-02 0.381249082892E-01 0.845866157243E-01 0.132122236961E+00 0.180522317286E+00
0.229567404370E+00 0.279029321687E+00 0.328672508685E+00 0.378255438406E+00 0.427532163428E+00
0.476254096171E+00 0.524172207141E+00 0.571039903275E+00 0.616616865042E+00 0.660673900196E+00
0.702998097735E+00 0.743396073735E+00 0.781691755158E+00 0.817716506082E+00 0.851295262156E+00
0.882238303138E+00 0.910345746539E+00 0.935421494478E+00 0.957287301571E+00 0.975791215624E+00
0.990810703323E+00 0.100225314176E+01 0.101005569110E+01 0.101418535318E+01 0.101463927790E+01
0.101144510801E+01 0.100466111497E+01 0.994375950448E+00 0.980707901591E+00 0.963803639329E+00
0.943836461172E+00 0.921004116597E+00 0.895526241359E+00 0.867641520215E+00 0.837604615000E+00
0.805682938619E+00 0.772153342384E+00 0.737298744582E+00 0.701404760904E+00 0.664756390336E+00
0.627634741711E+00 0.590313873286E+00 0.553057756365E+00 0.516117401327E+00 0.479728188657E+00
0.444107456577E+00 0.409452404308E+00 0.375938372688E+00 0.343717559055E+00 0.312918210115E+00
0.283644316716E+00 0.255975805584E+00 0.229969207138E+00 0.205658740221E+00 0.183057753088E+00
0.162160440109E+00
pseudo wavefunction
0.815477257113E-04 0.841994543121E-04 0.869374105116E-04 0.897643982160E-04 0.926833125078E-04
0.956971426101E-04 0.988089749485E-04 0.102021996311E-03 0.105339497112E-03 0.108764874763E-03
0.112301637149E-03 0.115953406224E-03 0.119723921719E-03 0.123617044970E-03 0.127636762877E-03
0.131787191981E-03 0.136072582684E-03 0.140497323602E-03 0.145065946054E-03 0.149783128710E-03
0.154653702376E-03 0.159682654946E-03 0.164875136506E-03 0.170236464611E-03 0.175772129729E-03
0.181487800864E-03 0.187389331363E-03 0.193482764908E-03 0.199774341708E-03 0.206270504887E-03
0.212977907082E-03 0.219903417260E-03 0.227054127747E-03 0.234437361494E-03 0.242060679579E-03
0.249931888944E-03 0.258059050395E-03 0.266450486854E-03 0.275114791884E-03 0.284060838489E-03
0.293297788203E-03 0.302835100467E-03 0.312682542321E-03 0.322850198405E-03 0.333348481284E-03
0.344188142117E-03 0.355380281661E-03 0.366936361642E-03 0.378868216494E-03 0.391188065475E-03
0.403908525185E-03 0.417042622483E-03 0.430603807827E-03 0.444605969054E-03 0.459063445594E-03
0.473991043162E-03 0.489404048917E-03 0.505318247117E-03 0.521749935286E-03 0.538715940900E-03
0.556233638623E-03 0.574320968101E-03 0.592996452329E-03 0.612279216623E-03 0.632189008208E-03
0.652746216436E-03 0.673971893671E-03 0.695887776845E-03 0.718516309720E-03 0.741880665872E-03
0.766004772421E-03 0.790913334538E-03 0.816631860740E-03 0.843186689018E-03 0.870605013804E-03
0.898914913826E-03 0.928145380856E-03 0.958326349405E-03 0.989488727376E-03 0.102166442772E-02
0.105488640110E-02 0.108918866967E-02 0.112460636188E-02 0.116117574846E-02 0.119893427959E-02
0.123792062320E-02 0.127817470463E-02 0.131973774745E-02 0.136265231574E-02 0.140696235763E-02
0.145271325033E-02 0.149995184660E-02 0.154872652270E-02 0.159908722798E-02 0.165108553598E-02
0.170477469728E-02 0.176020969402E-02 0.181744729618E-02 0.187654611977E-02 0.193756668679E-02
0.200057148727E-02 0.206562504320E-02 0.213279397464E-02 0.220214706796E-02 0.227375534621E-02
0.234769214192E-02 0.242403317215E-02 0.250285661605E-02 0.258424319488E-02 0.266827625473E-02
0.275504185178E-02 0.284462884051E-02 0.293712896461E-02 0.303263695098E-02 0.313125060667E-02
0.323307091910E-02 0.333820215938E-02 0.344675198915E-02 0.355883157079E-02 0.367455568123E-02
0.379404282948E-02 0.391741537797E-02 0.404479966782E-02 0.417632614823E-02 0.431212951000E-02
0.445234882345E-02 0.459712768080E-02 0.474661434319E-02 0.490096189243E-02 0.506032838775E-02
0.522487702760E-02 0.539477631671E-02 0.557020023861E-02 0.575132843370E-02 0.593834638314E-02
0.613144559871E-02 0.633082381885E-02 0.653668521102E-02 0.674924058070E-02 0.696870758709E-02
0.719531096592E-02 0.742928275939E-02 0.767086255365E-02 0.792029772395E-02 0.817784368774E-02
0.844376416603E-02 0.871833145320E-02 0.900182669552E-02 0.929454017879E-02 0.959677162528E-02
0.990883050022E-02 0.102310363284E-01 0.105637190207E-01 0.109072192118E-01 0.112618886081E-01
0.116280903475E-01 0.120061993704E-01 0.123966028031E-01 0.127997003533E-01 0.132159047187E-01
0.136456420083E-01 0.140893521779E-01 0.145474894794E-01 0.150205229247E-01 0.155089367643E-01
0.160132309818E-01 0.165339218041E-01 0.170715422280E-01 0.176266425639E-01 0.181997909971E-01
0.187915741665E-01 0.194025977634E-01 0.200334871477E-01 0.206848879853E-01 0.213574669051E-01
0.220519121780E-01 0.227689344162E-01 0.235092672965E-01 0.242736683058E-01 0.250629195101E-01
0.258778283492E-01 0.267192284556E-01 0.275879804997E-01 0.284849730625E-01 0.294111235351E-01
0.303673790471E-01 0.313547174243E-01 0.323741481766E-01 0.334267135170E-01 0.345134894124E-01
0.356355866676E-01 0.367941520430E-01 0.379903694070E-01 0.392254609246E-01 0.405006882824E-01
0.418173539515E-01 0.431768024894E-01 0.445804218815E-01 0.460296449237E-01 0.475259506471E-01
0.490708657851E-01 0.506659662856E-01 0.523128788672E-01 0.540132826228E-01 0.557689106695E-01
0.575815518475E-01 0.594530524680E-01 0.613853181118E-01 0.633803154786E-01 0.654400742896E-01
0.675666892425E-01 0.697623220209E-01 0.720292033587E-01 0.743696351597E-01 0.767859926737E-01
0.792807267296E-01 0.818563660248E-01 0.845155194735E-01 0.872608786111E-01 0.900952200573E-01
0.930214080363E-01 0.960423969533E-01 0.991612340281E-01 0.102381061984E+00 0.105705121788E+00
0.109136755450E+00 0.112679408862E+00 0.116336634695E+00 0.120112095333E+00 0.124009565855E+00
0.128032937043E+00 0.132186218436E+00 0.136473541398E+00 0.140899162210E+00 0.145467465175E+00
0.150182965720E+00 0.155050313498E+00 0.160074295467E+00 0.165259838936E+00 0.170612014565E+00
0.176136039306E+00 0.181837279254E+00 0.187721252402E+00 0.193793631261E+00 0.200060245332E+00
0.206527083389E+00 0.213200295545E+00 0.220086195059E+00 0.227191259846E+00 0.234522133635E+00
0.242085626730E+00 0.249888716306E+00 0.257938546178E+00 0.266242425963E+00 0.274807829557E+00
0.283642392830E+00 0.292753910429E+00 0.302150331579E+00 0.311839754749E+00 0.321830421030E+00
0.332130706074E+00 0.342749110390E+00 0.353694247819E+00 0.364974831931E+00 0.376599660114E+00
0.388577595046E+00 0.400917543253E+00 0.413628430375E+00 0.426719172761E+00 0.440198644933E+00
0.454075642432E+00 0.468358839485E+00 0.483056740881E+00 0.498177627359E+00 0.513729493745E+00
0.529719978972E+00 0.546156287045E+00 0.563045097863E+00 0.580392466756E+00 0.598203711387E+00
0.616483284604E+00 0.635234631621E+00 0.654460029761E+00 0.674160408817E+00 0.694335149890E+00
0.714981860357E+00 0.736096122431E+00 0.757671212527E+00 0.779697788452E+00 0.802163541211E+00
0.825052808008E+00 0.848346142836E+00 0.872019840898E+00 0.896045412985E+00 0.920389005890E+00
0.945010765014E+00 0.969864135460E+00 0.994895098271E+00 0.102004133900E+01 0.104523134664E+01
0.107038344193E+01 0.109540473587E+01 0.112019002089E+01 0.114462060011E+01 0.116856306300E+01
0.119186802024E+01 0.121436881520E+01 0.123588023556E+01 0.125619725611E+01 0.127509385139E+01
0.129232192750E+01 0.130761043238E+01 0.132066471690E+01 0.133116623170E+01 0.133877265895E+01
0.134311859223E+01 0.134381689101E+01 0.134046084846E+01 0.133262731962E+01 0.131988096144E+01
0.130177973302E+01 0.127788310298E+01 0.124791979347E+01 0.121195594119E+01 0.117012955700E+01
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00
ae wavefunction
0.100411206031E-02 0.103655653257E-02 0.107004824907E-02 0.110462094206E-02 0.114030942574E-02
0.117714963085E-02 0.121517864012E-02 0.125443472469E-02 0.129495738219E-02 0.133678737526E-02
0.137996677192E-02 0.142453898676E-02 0.147054882368E-02 0.151804251972E-02 0.156706779045E-02
0.161767387661E-02 0.166991159220E-02 0.172383337419E-02 0.177949333353E-02 0.183694730789E-02
0.189625291594E-02 0.195746961331E-02 0.202065875021E-02 0.208588363083E-02 0.215320957455E-02
0.222270397899E-02 0.229443638492E-02 0.236847854317E-02 0.244490448353E-02 0.252379058570E-02
0.260521565239E-02 0.268926098453E-02 0.277601045878E-02 0.286555060725E-02 0.295797069967E-02
0.305336282787E-02 0.315182199281E-02 0.325344619405E-02 0.335833652195E-02 0.346659725239E-02
0.357833594433E-02 0.369366354008E-02 0.381269446850E-02 0.393554675108E-02 0.406234211102E-02
0.419320608539E-02 0.432826814042E-02 0.446766179001E-02 0.461152471742E-02 0.475999890040E-02
0.491323073976E-02 0.507137119125E-02 0.523457590114E-02 0.540300534538E-02 0.557682497239E-02
0.575620534963E-02 0.594132231403E-02 0.613235712617E-02 0.632949662853E-02 0.653293340765E-02
0.674286596037E-02 0.695949886420E-02 0.718304295172E-02 0.741371548940E-02 0.765174036045E-02
0.789734825209E-02 0.815077684708E-02 0.841227101959E-02 0.868208303549E-02 0.896047275693E-02
0.924770785137E-02 0.954406400502E-02 0.984982514059E-02 0.101652836394E-01 0.104907405678E-01
0.108265059081E-01 0.111728987934E-01 0.115302477462E-01 0.118988909230E-01 0.122791763595E-01
0.126714622234E-01 0.130761170679E-01 0.134935200904E-01 0.139240613943E-01 0.143681422534E-01
0.148261753797E-01 0.152985851939E-01 0.157858080982E-01 0.162882927509E-01 0.168065003429E-01
0.173409048755E-01 0.178919934394E-01 0.184602664931E-01 0.190462381422E-01 0.196504364175E-01
0.202734035517E-01 0.209156962543E-01 0.215778859835E-01 0.222605592145E-01 0.229643177037E-01
0.236897787473E-01 0.244375754327E-01 0.252083568839E-01 0.260027884966E-01 0.268215521644E-01
0.276653464924E-01 0.285348869993E-01 0.294309063035E-01 0.303541542937E-01 0.313053982813E-01
0.322854231324E-01 0.332950313775E-01 0.343350432971E-01 0.354062969793E-01 0.365096483489E-01
0.376459711628E-01 0.388161569716E-01 0.400211150407E-01 0.412617722306E-01 0.425390728318E-01
0.438539783489E-01 0.452074672324E-01 0.466005345522E-01 0.480341916085E-01 0.495094654752E-01
0.510273984710E-01 0.525890475524E-01 0.541954836221E-01 0.558477907490E-01 0.575470652892E-01
0.592944149057E-01 0.610909574763E-01 0.629378198839E-01 0.648361366790E-01 0.667870486093E-01
0.687917010039E-01 0.708512420048E-01 0.729668206361E-01 0.751395846992E-01 0.773706784836E-01
0.796612402836E-01 0.820123997070E-01 0.844252747640E-01 0.869009687250E-01 0.894405667320E-01
0.920451321506E-01 0.947157026489E-01 0.974532859865E-01 0.100258855501E+00 0.103133345273E+00
0.106077644955E+00 0.109092594252E+00 0.112178977021E+00 0.115337514994E+00 0.118568861090E+00
0.121873592304E+00 0.125252202151E+00 0.128705092655E+00 0.132232565851E+00 0.135834814797E+00
0.139511914062E+00 0.143263809684E+00 0.147090308573E+00 0.150991067341E+00 0.154965580557E+00
0.159013168383E+00 0.163132963604E+00 0.167323898026E+00 0.171584688232E+00 0.175913820679E+00
0.180309536147E+00 0.184769813516E+00 0.189292352876E+00 0.193874557970E+00 0.198513517983E+00
0.203205988665E+00 0.207948372826E+00 0.212736700201E+00 0.217566606727E+00 0.222433313240E+00
0.227331603655E+00 0.232255802656E+00 0.237199752953E+00 0.242156792174E+00 0.247119729454E+00
0.252080821818E+00 0.257031750433E+00 0.261963596859E+00 0.266866819394E+00 0.271731229666E+00
0.276545969613E+00 0.281299489013E+00 0.285979523755E+00 0.290573075042E+00 0.295066389746E+00
0.299444942160E+00 0.303693417394E+00 0.307795696707E+00 0.311734845064E+00 0.315493101250E+00
0.319051870893E+00 0.322391722743E+00 0.325492388640E+00 0.328332767535E+00 0.330890934065E+00
0.333144152089E+00 0.335068893704E+00 0.336640864237E+00 0.337835033734E+00 0.338625675483E+00
0.338986412149E+00 0.338890270056E+00 0.338309742224E+00 0.337216860715E+00 0.335583278886E+00
0.333380364113E+00 0.330579301540E+00 0.327151209410E+00 0.323067266460E+00 0.318298851881E+00
0.312817698250E+00 0.306596057794E+00 0.299606882299E+00 0.291824016847E+00 0.283222407513E+00
0.273778323006E+00 0.263469590136E+00 0.252275842824E+00 0.240178784252E+00 0.227162461529E+00
0.213213552127E+00 0.198321661083E+00 0.182479627800E+00 0.165683841030E+00 0.147934560383E+00
0.129236242450E+00 0.109597869328E+00 0.890332769980E-01 0.675614806516E-01 0.452069935885E-01
0.220001358488E-01 -0.202267179947E-02 -0.268186333727E-01 -0.523383278445E-01 -0.785254890752E-01
-0.105316819838E+00 -0.132641842628E+00 -0.160422787359E+00 -0.188574512968E+00 -0.217004457521E+00
-0.245612611158E+00 -0.274291509649E+00 -0.302926253778E+00 -0.331394570066E+00 -0.359566938358E+00
-0.387306817382E+00 -0.414470996398E+00 -0.440910088322E+00 -0.466469161094E+00 -0.490988488296E+00
-0.514304394485E+00 -0.536250175925E+00 -0.556657087061E+00 -0.575355390912E+00 -0.592175474576E+00
-0.606949029250E+00 -0.619510290028E+00 -0.629697327922E+00 -0.637353382408E+00 -0.642328222232E+00
-0.644479521263E+00 -0.643674236664E+00 -0.639789976727E+00 -0.632716347271E+00 -0.622356265451E+00
-0.608627230644E+00 -0.591462542992E+00 -0.570812459931E+00 -0.546645281908E+00 -0.518948357967E+00
-0.487729002212E+00 -0.453015311567E+00 -0.414856874075E+00 -0.373325356806E+00 -0.328514960967E+00
-0.280542730002E+00 -0.229548696640E+00 -0.175695853364E+00 -0.119169931471E+00 -0.601789761144E-01
0.104729211497E-02 0.642583319031E-01 0.129183846977E+00 0.195535047578E+00 0.263006083041E+00
0.331275614340E+00 0.400008497553E+00 0.468857563600E+00 0.537465511386E+00 0.605466987922E+00
0.672491005793E+00 0.738163955532E+00 0.802113577363E+00 0.863974274314E+00 0.923393832698E+00
0.980040530008E+00 0.103360754150E+01 0.108380973017E+01 0.113036987200E+01 0.117299954389E+01
0.121138806437E+01 0.124520914300E+01 0.127414049534E+01 0.129788344230E+01 0.131617463165E+01
0.132879041294E+01 0.133554760128E+01 0.133630339312E+01 0.133095550857E+01 0.131944261315E+01
0.130174470424E+01 0.127788310298E+01 0.124791979347E+01 0.121195594119E+01 0.117012955700E+01
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00
pseudo wavefunction
0.291401325933E-08 0.310660738532E-08 0.331193051905E-08 0.353082395115E-08 0.376418457520E-08
0.401296856259E-08 0.427819528042E-08 0.456095146815E-08 0.486239569049E-08 0.518376308447E-08
0.552637042028E-08 0.589162149659E-08 0.628101289253E-08 0.669614009969E-08 0.713870405956E-08
0.761051813289E-08 0.811351552983E-08 0.864975723099E-08 0.922144043214E-08 0.983090754699E-08
0.104806558050E-07 0.111733474834E-07 0.119118208158E-07 0.126991016216E-07 0.135384157035E-07
0.144332020655E-07 0.153871270036E-07 0.164040991280E-07 0.174882853783E-07 0.186441280971E-07
0.198763632322E-07 0.211900397413E-07 0.225905402799E-07 0.240836032562E-07 0.256753463434E-07
0.273722915463E-07 0.291813919246E-07 0.311100600826E-07 0.331661985409E-07 0.353582321169E-07
0.376951424442E-07 0.401865047739E-07 0.428425272086E-07 0.456740925285E-07 0.486928027827E-07
0.519110268276E-07 0.553419510066E-07 0.589996331800E-07 0.628990603257E-07 0.670562099465E-07
0.714881155364E-07 0.762129363737E-07 0.812500319263E-07 0.866200411755E-07 0.923449671818E-07
0.984482672403E-07 0.104954948994E-06 0.111891672901E-06 0.119286861471E-06 0.127170815725E-06
0.135575839351E-06 0.144536371063E-06 0.154089125712E-06 0.164273244717E-06 0.175130456449E-06
0.186705247203E-06 0.199045043477E-06 0.212200406300E-06 0.226225238396E-06 0.241177005044E-06
0.257116969541E-06 0.274110444214E-06 0.292227058035E-06 0.311541041917E-06 0.332131532864E-06
0.354082898227E-06 0.377485081388E-06 0.402433970297E-06 0.429031790352E-06 0.457387523265E-06
0.487617353594E-06 0.519845144797E-06 0.554202946748E-06 0.590831536791E-06 0.629880996560E-06
0.671511326916E-06 0.715893103531E-06 0.763208175796E-06 0.813650411926E-06 0.867426493305E-06
0.924756761334E-06 0.985876120248E-06 0.105103499960E-05 0.112050038036E-05 0.119455688881E-05
0.127350796280E-05 0.135767709497E-05 0.144740915825E-05 0.154307181892E-05 0.164505704302E-05
0.175378270241E-05 0.186969428687E-05 0.199326672943E-05 0.212500635232E-05 0.226545294151E-05
0.241518195837E-05 0.257480689749E-05 0.274498180033E-05 0.292640393503E-05 0.311981665323E-05
0.332601243583E-05 0.354583613993E-05 0.378018846037E-05 0.403002962015E-05 0.429638330457E-05
0.458034085547E-05 0.488306574269E-05 0.520579833094E-05 0.554986096174E-05 0.591666337125E-05
0.630770846606E-05 0.672459848077E-05 0.716904154238E-05 0.764285866862E-05 0.814799122864E-05
0.868650889678E-05 0.926061813200E-05 0.987267121753E-05 0.105251758980E-04 0.112208056533E-04
0.119624106514E-04 0.127530294250E-04 0.135959013195E-04 0.144944797639E-04 0.154524464180E-04
0.164737262553E-04 0.175625036414E-04 0.187232394758E-04 0.199606894654E-04 0.212799236061E-04
0.226863469507E-04 0.241857217502E-04 0.257841910562E-04 0.274883038842E-04 0.293050420377E-04
0.312418487062E-04 0.333066589503E-04 0.355079322021E-04 0.378546869117E-04 0.403565374822E-04
0.430237336441E-04 0.458672024310E-04 0.488985929263E-04 0.521303239658E-04 0.555756349902E-04
0.592486402555E-04 0.631643866225E-04 0.673389151628E-04 0.717893268303E-04 0.765338524702E-04
0.815919274473E-04 0.869842712009E-04 0.927329720510E-04 0.988615775995E-04 0.105395191097E-03
0.112360574171E-03 0.119786256323E-03 0.127702651659E-03 0.136142183310E-03 0.145139416064E-03
0.154731197738E-03 0.164956809872E-03 0.175858128359E-03 0.187479794654E-03 0.199869398273E-03
0.213077671305E-03 0.227158695740E-03 0.242170124453E-03 0.258173416722E-03 0.275234089266E-03
0.293421983779E-03 0.312811552079E-03 0.333482159993E-03 0.355518411228E-03 0.379010492513E-03
0.404054541419E-03 0.430753038322E-03 0.459215224092E-03 0.489557545183E-03 0.521904127897E-03
0.556387283727E-03 0.593148047805E-03 0.632336752571E-03 0.674113638984E-03 0.718649507668E-03
0.766126412590E-03 0.816738400009E-03 0.870692295607E-03 0.928208542896E-03 0.989522096188E-03
0.105488337163E-02 0.112455925999E-02 0.119883420516E-02 0.127801135246E-02 0.136241377136E-02
0.145238575706E-02 0.154829421610E-02 0.165053014116E-02 0.175951018072E-02 0.187567830934E-02
0.199950760496E-02 0.213150213972E-02 0.227219899132E-02 0.242217038221E-02 0.258202595451E-02
0.275241518875E-02 0.293402997498E-02 0.312760734560E-02 0.333393237906E-02 0.355384128481E-02
0.378822467978E-02 0.403803106746E-02 0.430427053110E-02 0.458801865300E-02 0.489042067249E-02
0.521269589551E-02 0.555614236937E-02 0.592214183672E-02 0.631216498309E-02 0.672777699290E-02
0.717064342923E-02 0.764253645283E-02 0.814534139630E-02 0.868106370932E-02 0.925183629115E-02
0.985992722626E-02 0.105077479391E-01 0.111978617832E-01 0.119329930798E-01 0.127160366201E-01
0.135500676430E-01 0.144383523024E-01 0.153843586304E-01 0.163917680069E-01 0.174644871387E-01
0.186066605500E-01 0.198226835816E-01 0.211172158919E-01 0.224951954467E-01 0.239618529776E-01
0.255227268840E-01 0.271836785399E-01 0.289509079627E-01 0.308309697832E-01 0.328307894472E-01
0.349576795609E-01 0.372193562769E-01 0.396239555947E-01 0.421800494316E-01 0.448966612888E-01
0.477832813164E-01 0.508498805412E-01 0.541069239936E-01 0.575653824260E-01 0.612367422726E-01
0.651330134572E-01 0.692667345974E-01 0.736509751040E-01 0.782993336099E-01 0.832259320992E-01
0.884454050389E-01 0.939728827426E-01 0.998239681194E-01 0.106014705886E+00 0.112561543240E+00
0.119481280915E+00 0.126791013465E+00 0.134508057562E+00 0.142649867018E+00 0.151233933217E+00
0.160277669592E+00 0.169798278812E+00 0.179812601329E+00 0.190336944040E+00 0.201386887920E+00
0.212977073642E+00 0.225120964474E+00 0.237830586025E+00 0.251116242866E+00 0.264986212540E+00
0.279446418120E+00 0.294500081243E+00 0.310147358389E+00 0.326384964240E+00 0.343205787016E+00
0.360598501964E+00 0.378547190403E+00 0.397030973061E+00 0.416023667596E+00 0.435493481275E+00
0.455402750406E+00 0.475707738325E+00 0.496358503092E+00 0.517298844394E+00 0.538466336048E+00
0.559792445588E+00 0.581202735249E+00 0.602617128756E+00 0.623950215269E+00 0.645111545175E+00
0.666005852012E+00 0.686533110574E+00 0.706588313742E+00 0.726060820598E+00 0.744833097986E+00
0.762778649522E+00 0.779758904490E+00 0.795618829863E+00 0.810181039602E+00 0.823238215978E+00
0.834543739524E+00 0.843795380124E+00 0.850759109567E+00 0.855372161004E+00 0.857616014165E+00
0.857488659294E+00 0.855004671928E+00 0.850195047582E+00 0.843106865393E+00 0.833802777701E+00
0.822360362211E+00 0.808871363829E+00 0.793440811751E+00 0.776186049690E+00 0.757235651501E+00
0.736728220047E+00 0.714811061352E+00 0.691638711026E+00 0.667371314245E+00 0.642172855225E+00
0.616209261527E+00 0.589646422683E+00 0.562648185013E+00 0.535374398390E+00 0.507979097643E+00
0.480608903449E+00 0.453401664511E+00 0.426485488588E+00 0.399978037834E+00 0.373986187145E+00
0.348605971935E+00
ae wavefunction
-0.227640005255E-06 -0.241553109009E-06 -0.256238555862E-06 -0.271743807437E-06 -0.288119059293E-06
-0.305417409476E-06 -0.323695040919E-06 -0.343011420299E-06 -0.363429495424E-06 -0.385015922933E-06
-0.407841293332E-06 -0.431980383418E-06 -0.457512411824E-06 -0.484521323890E-06 -0.513096081958E-06
-0.543330981917E-06 -0.575325988290E-06 -0.609187085051E-06 -0.645026656992E-06 -0.682963888178E-06
-0.723125189070E-06 -0.765644650027E-06 -0.810664522779E-06 -0.858335733716E-06 -0.908818428675E-06
-0.962282552862E-06 -0.101890846811E-05 -0.107888760881E-05 -0.114242318028E-05 -0.120973090157E-05
-0.128103979581E-05 -0.135659303138E-05 -0.143664881687E-05 -0.152148135361E-05 -0.161138184934E-05
-0.170665959719E-05 -0.180764312397E-05 -0.191468141270E-05 -0.202814520350E-05 -0.214842837891E-05
-0.227594943811E-05 -0.241115306706E-05 -0.255451180887E-05 -0.270652784384E-05 -0.286773488278E-05
-0.303870018477E-05 -0.322002670283E-05 -0.341235537132E-05 -0.361636753939E-05 -0.383278756495E-05
-0.406238557063E-05 -0.430598038508E-05 -0.456444267121E-05 -0.483869825746E-05 -0.512973168541E-05
-0.543858998763E-05 -0.576638670788E-05 -0.611430618730E-05 -0.648360812039E-05 -0.687563241512E-05
-0.729180435834E-05 -0.773364012362E-05 -0.820275263428E-05 -0.870085779960E-05 -0.922978116481E-05
-0.979146498304E-05 -0.103879757491E-04 -0.110215122190E-04 -0.116944139499E-04 -0.124091703881E-04
-0.131684305501E-04 -0.139750133231E-04 -0.148319184326E-04 -0.157423381229E-04 -0.167096695752E-04
-0.177375281589E-04 -0.188297614847E-04 -0.199904644287E-04 -0.212239950522E-04 -0.225349916140E-04
-0.239283906270E-04 -0.254094460867E-04 -0.269837499631E-04 -0.286572539548E-04 -0.304362926902E-04
-0.323276083849E-04 -0.343383770722E-04 -0.364762365488E-04 -0.387493160542E-04 -0.411662678874E-04
-0.437363010297E-04 -0.464692168819E-04 -0.493754473295E-04 -0.524660951748E-04 -0.557529771750E-04
-0.592486697906E-04 -0.629665578455E-04 -0.669208862560E-04 -0.711268150389E-04 -0.756004777882E-04
-0.803590438379E-04 -0.854207843420E-04 -0.908051425042E-04 -0.965328082167E-04 -0.102625797380E-03
-0.109107536177E-03 -0.116002950618E-03 -0.123338561665E-03 -0.131142586270E-03 -0.139445044700E-03
-0.148277874493E-03 -0.157675051496E-03 -0.167672718328E-03 -0.178309320794E-03 -0.189625752649E-03
-0.201665509253E-03 -0.214474850611E-03 -0.228102974334E-03 -0.242602199160E-03 -0.258028159541E-03
-0.274440012047E-03 -0.291900654171E-03 -0.310476956278E-03 -0.330240007458E-03 -0.351265376027E-03
-0.373633385506E-03 -0.397429406962E-03 -0.422744168568E-03 -0.449674083345E-03 -0.478321596087E-03
-0.508795550462E-03 -0.541211577400E-03 -0.575692505860E-03 -0.612368797176E-03 -0.651379004183E-03
-0.692870256384E-03 -0.736998772502E-03 -0.783930401758E-03 -0.833841195310E-03 -0.886918009300E-03
-0.943359141058E-03 -0.100337499998E-02 -0.106718881472E-02 -0.113503737838E-02 -0.120717183327E-02
-0.128385849716E-02 -0.136537973262E-02 -0.145203486135E-02 -0.154414112528E-02 -0.164203469631E-02
-0.174607173654E-02 -0.185662951080E-02 -0.197410755347E-02 -0.209892889124E-02 -0.223154132379E-02
-0.237241876400E-02 -0.252206263958E-02 -0.268100335757E-02 -0.284980183333E-02 -0.302905108546E-02
-0.321937789790E-02 -0.342144455020E-02 -0.363595061718E-02 -0.386363483818E-02 -0.410527705682E-02
-0.436170023094E-02 -0.463377251275E-02 -0.492240939836E-02 -0.522857594571E-02 -0.555328905920E-02
-0.589761983893E-02 -0.626269599168E-02 -0.664970430008E-02 -0.705989314585E-02 -0.749457508176E-02
-0.795512944634E-02 -0.844300501417E-02 -0.895972267341E-02 -0.950687812113E-02 -0.100861445655E-01
-0.106992754225E-01 -0.113481069932E-01 -0.120345611055E-01 -0.127606477039E-01 -0.135284673660E-01
-0.143402137256E-01 -0.151981757772E-01 -0.161047400361E-01 -0.170623925242E-01 -0.180737205506E-01
-0.191414142506E-01 -0.202682678463E-01 -0.214571805872E-01 -0.227111573254E-01 -0.240333086777E-01
-0.254268507220E-01 -0.268951041730E-01 -0.284414929755E-01 -0.300695422528E-01 -0.317828755418E-01
-0.335852112415E-01 -0.354803581988E-01 -0.374722103520E-01 -0.395647403441E-01 -0.417619920209E-01
-0.440680717173E-01 -0.464871382391E-01 -0.490233914373E-01 -0.516810592766E-01 -0.544643832889E-01
-0.573776023104E-01 -0.604249343909E-01 -0.636105567713E-01 -0.669385838208E-01 -0.704130428314E-01
-0.740378475674E-01 -0.778167694752E-01 -0.817534064637E-01 -0.858511491736E-01 -0.901131446652E-01
-0.945422574669E-01 -0.991410279388E-01 -0.103911627924E+00 -0.108855813683E+00 -0.113974876119E+00
-0.119269588339E+00 -0.124740150612E+00 -0.130386132824E+00 -0.136206414546E+00 -0.142199122910E+00
-0.148361568461E+00 -0.154690179275E+00 -0.161180433629E+00 -0.167826791604E+00 -0.174622626074E+00
-0.181560153598E+00 -0.188630365898E+00 -0.195822962666E+00 -0.203126286646E+00 -0.210527262067E+00
-0.218011337617E+00 -0.225562435281E+00 -0.233162906153E+00 -0.240793494317E+00 -0.248433308678E+00
-0.256059802119E+00 -0.263648755337E+00 -0.271174261340E+00 -0.278608705431E+00 -0.285922735843E+00
-0.293085222680E+00 -0.300063207642E+00 -0.306821853310E+00 -0.313324406907E+00 -0.319532197048E+00
-0.325404681082E+00 -0.330899553728E+00 -0.335972916269E+00 -0.340579493605E+00 -0.344672879916E+00
-0.348205795435E+00 -0.351130344647E+00 -0.353398274582E+00 -0.354961236968E+00 -0.355771059088E+00
-0.355780026627E+00 -0.354941178528E+00 -0.353208612936E+00 -0.350537800929E+00 -0.346885905093E+00
-0.342212099803E+00 -0.336477890709E+00 -0.329647431117E+00 -0.321687833920E+00 -0.312569477680E+00
-0.302266305867E+00 -0.290756118642E+00 -0.278020856318E+00 -0.264046873976E+00 -0.248825206279E+00
-0.232351821598E+00 -0.214627864069E+00 -0.195659881552E+00 -0.175460037164E+00 -0.154046301204E+00
-0.131442619230E+00 -0.107679051851E+00 -0.827918807912E-01 -0.568236757344E-01 -0.298233169267E-01
-0.184596946076E-02 0.270469925154E-01 0.567881103967E-01 0.873040093439E-01 0.118515601298E+00
0.150338311437E+00 0.182682317934E+00 0.215452801690E+00 0.248550217585E+00 0.281870625756E+00
0.315306159094E+00 0.348745757632E+00 0.382076358511E+00 0.415184751019E+00 0.447960169991E+00
0.480297184335E+00 0.512097402331E+00 0.543267514780E+00 0.573711997895E+00 0.603322786216E+00
0.631972550728E+00 0.659516794793E+00 0.685802869564E+00 0.710679507526E+00 0.734002706130E+00
0.755638016764E+00 0.775461068324E+00 0.793357768618E+00 0.809224794004E+00 0.822970440992E+00
0.834515701559E+00 0.843795380124E+00 0.850759109567E+00 0.855372161004E+00 0.857616014165E+00
0.857488659294E+00 0.855004671928E+00 0.850195047582E+00 0.843106865393E+00 0.833802777701E+00
0.822360362211E+00 0.808871363829E+00 0.793440811751E+00 0.776186049690E+00 0.757235651501E+00
0.736728220047E+00 0.714811061352E+00 0.691638711026E+00 0.667371314245E+00 0.642172855225E+00
0.616209261527E+00 0.589646422683E+00 0.562648185013E+00 0.535374398390E+00 0.507979097643E+00
0.480608903449E+00 0.453401664511E+00 0.426485488588E+00 0.399978037834E+00 0.373986187145E+00
0.348605971935E+00
pseudo wavefunction
0.571859011433E-08 0.609654545181E-08 0.649948076408E-08 0.692904703757E-08 0.738700437639E-08
0.787522921411E-08 0.839572200233E-08 0.895061540728E-08 0.954218304822E-08 0.101728488133E-07
0.108451967914E-07 0.115619818599E-07 0.123261409726E-07 0.131408051936E-07 0.140093125268E-07
0.149352215925E-07 0.159223262088E-07 0.169746709363E-07 0.180965676505E-07 0.192926132088E-07
0.205677082861E-07 0.219270774547E-07 0.233762905912E-07 0.249212856987E-07 0.265683932374E-07
0.283243620625E-07 0.301963870773E-07 0.321921387136E-07 0.343197943601E-07 0.365880718690E-07
0.390062652761E-07 0.415842828822E-07 0.443326878514E-07 0.472627414928E-07 0.503864494020E-07
0.537166106534E-07 0.572668702427E-07 0.610517749960E-07 0.650868331739E-07 0.693885780150E-07
0.739746354790E-07 0.788637964676E-07 0.840760938177E-07 0.896328843845E-07 0.955569365484E-07
0.101872523507E-06 0.108605522730E-06 0.115783521992E-06 0.123435932409E-06 0.131594108947E-06
0.140291478898E-06 0.149563678840E-06 0.159448700661E-06 0.169987047220E-06 0.181221898307E-06
0.193199287567E-06 0.205968291118E-06 0.219581228634E-06 0.234093877719E-06 0.249565702454E-06
0.266060097037E-06 0.283644645541E-06 0.302391398829E-06 0.322377169775E-06 0.343683847994E-06
0.366398735382E-06 0.390614903817E-06 0.416431576518E-06 0.443954534597E-06 0.473296550488E-06
0.504577850014E-06 0.537926605003E-06 0.573479458457E-06 0.611382084429E-06 0.651789784903E-06
0.694868126132E-06 0.740793617018E-06 0.789754432343E-06 0.841951183784E-06 0.897597741903E-06
0.956922112447E-06 0.102016737058E-05 0.108759265684E-05 0.115947423894E-05 0.123610664376E-05
0.131780386409E-05 0.140490064518E-05 0.149775385636E-05 0.159674395320E-05 0.170227653640E-05
0.181478401368E-05 0.193472737149E-05 0.206259806386E-05 0.219892002601E-05 0.234425182114E-05
0.249918892902E-05 0.266436618586E-05 0.284046038547E-05 0.302819305228E-05 0.322833339765E-05
0.344170147158E-05 0.366917152271E-05 0.391167558034E-05 0.417020727329E-05 0.444582590101E-05
0.473966077387E-05 0.505291584021E-05 0.538687461930E-05 0.574290546014E-05 0.612246714800E-05
0.652711488135E-05 0.695850664388E-05 0.741840999759E-05 0.790870932483E-05 0.843141354897E-05
0.898866436529E-05 0.958274501585E-05 0.102160896442E-04 0.108912932684E-04 0.116111224130E-04
0.123785264438E-04 0.131966496516E-04 0.140688441343E-04 0.149986835308E-04 0.159899776617E-04
0.170467881383E-04 0.181734450030E-04 0.193745644683E-04 0.206550678297E-04 0.220202016265E-04
0.234755591366E-04 0.250271032906E-04 0.266811910997E-04 0.284445996990E-04 0.303245541103E-04
0.323287568402E-04 0.344654194334E-04 0.367432961109E-04 0.391717196309E-04 0.417606395186E-04
0.445206628220E-04 0.474630975606E-04 0.505999990437E-04 0.539442192495E-04 0.575094594655E-04
0.613103264068E-04 0.653623920412E-04 0.696822573653E-04 0.742876203945E-04 0.791973486423E-04
0.844315563875E-04 0.900116870435E-04 0.959606009681E-04 0.102302669071E-03 0.109063872604E-03
0.116271909536E-03 0.123956307960E-03 0.132148546974E-03 0.140882185556E-03 0.150192999936E-03
0.160119130038E-03 0.170701235589E-03 0.181982662526E-03 0.194009620390E-03 0.206831371412E-03
0.220500432088E-03 0.235072788041E-03 0.250608123054E-03 0.267170063210E-03 0.284826437132E-03
0.303649553366E-03 0.323716496065E-03 0.345109440149E-03 0.367915987228E-03 0.392229523661E-03
0.418149602194E-03 0.445782348728E-03 0.475240895864E-03 0.506645844977E-03 0.540125758697E-03
0.575817685783E-03 0.613867720498E-03 0.654431598766E-03 0.697675333489E-03 0.743775891598E-03
0.792921915550E-03 0.845314492176E-03 0.901167971957E-03 0.960710842010E-03 0.102418665628E-02
0.109185502664E-02 0.116399267887E-02 0.124089457767E-02 0.132287512520E-02 0.141026943799E-02
0.150343470699E-02 0.160275164648E-02 0.170862603724E-02 0.182149037022E-02 0.194180559698E-02
0.207006299390E-02 0.220678614720E-02 0.235253306661E-02 0.250789843574E-02 0.267351600781E-02
0.285006115589E-02 0.303825358734E-02 0.323886023271E-02 0.345269831994E-02 0.368063864538E-02
0.392360905372E-02 0.418259813975E-02 0.445865918532E-02 0.475291434595E-02 0.506655910210E-02
0.540086699085E-02 0.575719463481E-02 0.613698708574E-02 0.654178350122E-02 0.697322317377E-02
0.743305193259E-02 0.792312893904E-02 0.844543389789E-02 0.900207470735E-02 0.959529557187E-02
0.102274856023E-01 0.109011879290E-01 0.116191093550E-01 0.123841305757E-01 0.131993169929E-01
0.140679301526E-01 0.149934398347E-01 0.159795368236E-01 0.170301463902E-01 0.181494425124E-01
0.193418628649E-01 0.206121246052E-01 0.219652409824E-01 0.234065387949E-01 0.249416767187E-01
0.265766645285E-01 0.283178832261E-01 0.301721060910E-01 0.321465206585E-01 0.342487516267E-01
0.364868846862E-01 0.388694912556E-01 0.414056540969E-01 0.441049937706E-01 0.469776958777E-01
0.500345390167E-01 0.532869233644E-01 0.567468997676E-01 0.604271992062E-01 0.643412624556E-01
0.685032697477E-01 0.729281701846E-01 0.776317106202E-01 0.826304636723E-01 0.879418544734E-01
0.935841857035E-01 0.995766603828E-01 0.105939401817E+00 0.112693470009E+00 0.119860873746E+00
0.127464577480E+00 0.135528501980E+00 0.144077517640E+00 0.153137429157E+00 0.162734950176E+00
0.172897666316E+00 0.183653984845E+00 0.195033069077E+00 0.207064755401E+00 0.219779450647E+00
0.233208007313E+00 0.247381573997E+00 0.262331418175E+00 0.278088718331E+00 0.294684322281E+00
0.312148468415E+00 0.330510466534E+00 0.349798334922E+00 0.370038390351E+00 0.391254787886E+00
0.413469007585E+00 0.436699285593E+00 0.460959987670E+00 0.486260923917E+00 0.512606604396E+00
0.539995436506E+00 0.568418866379E+00 0.597860468269E+00 0.628294987815E+00 0.659687347350E+00
0.691991623811E+00 0.725150012533E+00 0.759091792928E+00 0.793732314786E+00 0.828972026523E+00
0.864695568746E+00 0.900770957920E+00 0.937048885087E+00 0.973362153233E+00 0.100952527329E+01
0.104533423238E+01 0.108056643801E+01 0.111498082794E+01 0.114831811634E+01 0.118030112315E+01
0.121063510361E+01 0.123900796074E+01 0.126509018530E+01 0.128853432805E+01 0.130897377168E+01
0.132602054064E+01 0.133926187406E+01 0.134825530053E+01 0.135252200835E+01 0.135153841669E+01
0.134472604132E+01 0.133144140608E+01 0.131113985918E+01 0.128359157702E+01 0.124863807676E+01
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00
ae wavefunction
-0.419591673479E-06 -0.445236660954E-06 -0.472305250687E-06 -0.500884925173E-06 -0.531068206171E-06
-0.562952965377E-06 -0.596642760627E-06 -0.632247202450E-06 -0.669882317876E-06 -0.709670970157E-06
-0.751743273549E-06 -0.796237058589E-06 -0.843298343123E-06 -0.893081857389E-06 -0.945751579095E-06
-0.100148131688E-05 -0.106045532797E-05 -0.112286896479E-05 -0.118892937793E-05 -0.125885625057E-05
-0.133288258579E-05 -0.141125554245E-05 -0.149423732267E-05 -0.158210611794E-05 -0.167515711327E-05
-0.177370355614E-05 -0.187807789421E-05 -0.198863298444E-05 -0.210574338018E-05 -0.222980670049E-05
-0.236124508686E-05 -0.250050675369E-05 -0.264806763788E-05 -0.280443315455E-05 -0.297014006557E-05
-0.314575846823E-05 -0.333189391186E-05 -0.352918965126E-05 -0.373832904445E-05 -0.396003810621E-05
-0.419508822539E-05 -0.444429905901E-05 -0.470854161112E-05 -0.498874151386E-05 -0.528588251725E-05
-0.560101020839E-05 -0.593523596640E-05 -0.628974117866E-05 -0.666578172614E-05 -0.706469276477E-05
-0.748789380520E-05 -0.793689413439E-05 -0.841329858154E-05 -0.891881365848E-05 -0.945525409868E-05
-0.100245498207E-04 -0.106287533383E-04 -0.112700476609E-04 -0.119507546913E-04 -0.126733441838E-04
-0.134404432655E-04 -0.142548465883E-04 -0.151195271357E-04 -0.160376477180E-04 -0.170125732291E-04
-0.180478836822E-04 -0.191473880961E-04 -0.203151392770E-04 -0.215554495594E-04 -0.228729075576E-04
-0.242723960099E-04 -0.257591107648E-04 -0.273385809967E-04 -0.290166907359E-04 -0.307997017578E-04
-0.326942780077E-04 -0.347075115045E-04 -0.368469500336E-04 -0.391206264891E-04 -0.415370902338E-04
-0.441054403792E-04 -0.468353612296E-04 -0.497371600521E-04 -0.528218071755E-04 -0.561009787541E-04
-0.595871022176E-04 -0.632934046196E-04 -0.672339641473E-04 -0.714237648284E-04 -0.758787548062E-04
-0.806159083152E-04 -0.856532915520E-04 -0.910101328385E-04 -0.967068971463E-04 -0.102765365426E-03
-0.109208718933E-03 -0.116061628915E-03 -0.123350351965E-03 -0.131102831408E-03 -0.139348805092E-03
-0.148119919962E-03 -0.157449853863E-03 -0.167374444991E-03 -0.177931829462E-03 -0.189162587521E-03
-0.201109898875E-03 -0.213819707747E-03 -0.227340898203E-03 -0.241725480395E-03 -0.257028788379E-03
-0.273309690165E-03 -0.290630810807E-03 -0.309058769194E-03 -0.328664429493E-03 -0.349523167966E-03
-0.371715156200E-03 -0.395325661615E-03 -0.420445366275E-03 -0.447170705143E-03 -0.475604224753E-03
-0.505854963647E-03 -0.538038855679E-03 -0.572279157541E-03 -0.608706901916E-03 -0.647461377632E-03
-0.688690638341E-03 -0.732552041357E-03 -0.779212818233E-03 -0.828850678842E-03 -0.881654450829E-03
-0.937824756232E-03 -0.997574727349E-03 -0.106113076385E-02 -0.112873333333E-02 -0.120063781758E-02
-0.127711540679E-02 -0.135845404425E-02 -0.144495942405E-02 -0.153695604425E-02 -0.163478831840E-02
-0.173882174815E-02 -0.184944415970E-02 -0.196706700731E-02 -0.209212674663E-02 -0.222508628119E-02
-0.236643648517E-02 -0.251669780565E-02 -0.267642194774E-02 -0.284619364598E-02 -0.302663252522E-02
-0.321839505467E-02 -0.342217659827E-02 -0.363871356504E-02 -0.386878566260E-02 -0.411321825733E-02
-0.437288484423E-02 -0.464870962994E-02 -0.494167023156E-02 -0.525280049427E-02 -0.558319343043E-02
-0.593400428227E-02 -0.630645371041E-02 -0.670183110977E-02 -0.712149805405E-02 -0.756689186960E-02
-0.803952933881E-02 -0.854101053252E-02 -0.907302277019E-02 -0.963734470585E-02 -0.102358505368E-01
-0.108705143308E-01 -0.115434144674E-01 -0.122567381851E-01 -0.130127862287E-01 -0.138139775855E-01
-0.146628542996E-01 -0.155620863515E-01 -0.165144765871E-01 -0.175229656786E-01 -0.185906370974E-01
-0.197207220752E-01 -0.209166045292E-01 -0.221818259204E-01 -0.235200900133E-01 -0.249352675010E-01
-0.264314004551E-01 -0.280127065554E-01 -0.296835830510E-01 -0.314486103986E-01 -0.333125555181E-01
-0.352803746019E-01 -0.373572154063E-01 -0.395484189494E-01 -0.418595205316E-01 -0.442962499902E-01
-0.468645310902E-01 -0.495704799483E-01 -0.524204023797E-01 -0.554207900464E-01 -0.585783152843E-01
-0.618998244709E-01 -0.653923297941E-01 -0.690629992720E-01 -0.729191448635E-01 -0.769682085087E-01
-0.812177459231E-01 -0.856754079688E-01 -0.903489194169E-01 -0.952460549124E-01 -0.100374611944E+00
-0.105742380623E+00 -0.111357110073E+00 -0.117226471226E+00 -0.123358015834E+00 -0.129759131487E+00
-0.136436992474E+00 -0.143398506273E+00 -0.150650255536E+00 -0.158198435396E+00 -0.166048785958E+00
-0.174206519886E+00 -0.182676244971E+00 -0.191461881646E+00 -0.200566575426E+00 -0.209992604279E+00
-0.219741281025E+00 -0.229812850838E+00 -0.240206384069E+00 -0.250919664576E+00 -0.261949073908E+00
-0.273289471686E+00 -0.284934072667E+00 -0.296874321046E+00 -0.309099762684E+00 -0.321597916090E+00
-0.334354143130E+00 -0.347351520683E+00 -0.360570714663E+00 -0.373989858114E+00 -0.387584435372E+00
-0.401327174519E+00 -0.415187950525E+00 -0.429133701186E+00 -0.443128357849E+00 -0.457132790725E+00
-0.471104767691E+00 -0.484998921703E+00 -0.498766719483E+00 -0.512356422012E+00 -0.525713027989E+00
-0.538778196066E+00 -0.551490150480E+00 -0.563783586393E+00 -0.575589602443E+00 -0.586835694684E+00
-0.597445844316E+00 -0.607340718942E+00 -0.616437986018E+00 -0.624652715226E+00 -0.631897834510E+00
-0.638084607775E+00 -0.643123116697E+00 -0.646922744393E+00 -0.649392668142E+00 -0.650442370237E+00
-0.649982173269E+00 -0.647923800099E+00 -0.644180957099E+00 -0.638669934919E+00 -0.631310221677E+00
-0.622025123195E+00 -0.610742386067E+00 -0.597394819740E+00 -0.581920915553E+00 -0.564265460645E+00
-0.544380145344E+00 -0.522224163384E+00 -0.497764803837E+00 -0.470978034224E+00 -0.441849073512E+00
-0.410372953728E+00 -0.376555068042E+00 -0.340411701856E+00 -0.301970542890E+00 -0.261271164549E+00
-0.218365474934E+00 -0.173318123362E+00 -0.126206854463E+00 -0.771227997739E-01 -0.261706977118E-01
0.265309653866E-01 0.808498960908E-01 0.136640013874E+00 0.193741540297E+00 0.251981141124E+00
0.311172100787E+00 0.371114512072E+00 0.431595477829E+00 0.492389350851E+00 0.553258089799E+00
0.613951880087E+00 0.674210269543E+00 0.733764172796E+00 0.792339126527E+00 0.849659904580E+00
0.905455616556E+00 0.959462488428E+00 0.101141974424E+01 0.106105567211E+01 0.110806847980E+01
0.115211437455E+01 0.119281223958E+01 0.122976095463E+01 0.126255737984E+01 0.129080748835E+01
0.131413097418E+01 0.133216280306E+01 0.134455435589E+01 0.135097524786E+01 0.135111592592E+01
0.134469077582E+01 0.133144140608E+01 0.131113985918E+01 0.128359157702E+01 0.124863807676E+01
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00 0.000000000000E+00
0.000000000000E+00
End of Dataset
#!/bin/bash
#PBS -A OPEN-6-23
#PBS -N Si-test1
#PBS -q qfree
#PBS -l select=1:ncpus=24:mpiprocs=24:ompthreads=1
#PBS -l walltime=01:59:59
##PBS-l mem=6gb
#PBS -j oe
#PBS -S /bin/bash
module purge
module load phono3py/0.9.14-ictce-7.3.5-Python-2.7.9
export OMP_NUM_THREADS=1
export I_MPI_COMPATIBILITY=4
##export OMP_STACKSIZE=10gb
##0 1 2 3 4 10 11 12 13 20 21 22 30 31 40 91 92 93 94 101 102 103 111 112 121 182 183 184 192 193 202 273 274 283 364
cd $PBS_O_WORKDIR
phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="0 1 3 4 10"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="11 12 13 20 21"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="21 22 30 31 40"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="91 92 93 94 101"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="102 103 111 112 121"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="182 183 184 192 193"
#phono3py --fc3 --fc2 --dim="2 2 2" --mesh="9 9 9" -c POSCAR --sigma 0.1 --br --write_gamma --gp="202 273 274 283 364"
#!/bin/bash
P=`pwd`
# number of displacements
poc=9
for i in `seq 1 $poc `;
do
cd $P
mkdir disp-0000"$i"
cd disp-0000"$i"
cp ../KPOINTS .
cp ../INCAR .
cp ../POTCAR .
cp ../POSCAR-0000"$i" POSCAR
echo $i
done
poc=99
for i in `seq 10 $poc `;
do
cd $P
mkdir disp-000"$i"
cd disp-000"$i"
cp ../KPOINTS .
cp ../INCAR .
cp ../POTCAR .
cp ../POSCAR-000"$i" POSCAR
echo $i
done
poc=111
for i in `seq 100 $poc `;
do
cd $P
mkdir disp-00"$i"
cd disp-00"$i"
cp ../KPOINTS .
cp ../INCAR .
cp ../POTCAR .
cp ../POSCAR-00"$i" POSCAR
echo $i
done
#!/bin/bash
#PBS -A IT4I-9-11
#PBS -N Si-test
#PBS -q qprod
#PBS -l select=8:ncpus=16:mpiprocs=16:ompthreads=1
#PBS -l walltime=23:59:59
##PBS-l mem=6gb
#PBS -j oe
#PBS -S /bin/bash
module load impi/4.1.1.036 intel/13.5.192 fftw3-mpi/3.3.3-icc
export OMP_NUM_THREADS=1
export I_MPI_COMPATIBILITY=4
##export OMP_STACKSIZE=10gb
b=`basename $PBS_O_WORKDIR`
echo $b >log.vasp
SCRDIR=/scratch/$USER/$b
mkdir -p $SCRDIR
cd $SCRDIR || exit
# copy input file to scratch
cp $PBS_O_WORKDIR/* .
mpirun ~/bin/vasp5.4.1 > log.exc
# copy output file to home
cp * $PBS_O_WORKDIR/. && cd ..
rm -rf "$SCRDIR"
#exit
exit
#!/bin/bash
P=`pwd`
# number of displacements
poc=9
for i in `seq 1 $poc `;
do
cd $P
cd disp-0000"$i"
cp ../run.sh .
qsub run.sh
echo $i
done
poc=99
for i in `seq 10 $poc `;
do
cd $P
cd disp-000"$i"
cp ../run.sh .
qsub run.sh
echo $i
done
poc=111
for i in `seq 100 $poc `;
do
cd $P
cd disp-00"$i"
cp ../run.sh .
qsub run.sh
echo $i
done
# General Setup
SYSTEM = Aluminum # Calculation Title
PREC = Accurate # Options: Low, Medium, High, Normal, accurate
ENCUT = 350 # Kinetic Energy Cutoff in eV
# Electronic Relaxation
NELMIN = 5 # Min Number of ESC steps
EDIFF = 1E-8 # Global Break Condition for the Elec SC-loop
LREAL = .FALSE. # Real Space Projection
ADDGRID = .TRUE. # Improve the Grid Accuracy
# Ionic Relaxation - we need to calculate one displacement
SIGMA = 0.1 # Insulators/semiconductors=0.1 metals=0.05
ISMEAR = 1
IBRION = -1
Auto corresponding to 8 8 8
0
Auto
35
Al4
1.00000000000000
4.0432254711710000 0.0000000000000000 0.0000000000000000
0.0000000000000000 4.0432254711710000 0.0000000000000000
0.0000000000000000 0.0000000000000000 4.0432254711710000
Al
4
Direct
0.0000000000000000 0.0000000000000000 0.0000000000000000
0.0000000000000000 0.5000000000000000 0.5000000000000000
0.5000000000000000 0.0000000000000000 0.5000000000000000
0.5000000000000000 0.5000000000000000 0.0000000000000000
ATOM_NAME = Al
DIM = 2 2 2
MESH = 12 12 12
DISPLACEMENT_DISTANCE = 0.01
PRIMITIVE_AXES = Auto
# Gaussian
## Introduction
Gaussian provides state-of-the-art capabilities for electronic structure modeling.
Gaussian provides a wide-ranging suite of the most advanced modeling capabilities available.
Starting from the fundamental laws of quantum mechanics, Gaussian predicts the energies, molecular structures, vibrational frequencies, and molecular properties of compounds and reactions in a wide variety of chemical environments.
Gaussians models can be applied to both stable species and compounds that are difficult or impossible to observe experimentally.
For more information, see the [official webpage][a].
## License
Starting April 1, 2025, Gaussian will only be available to VSB-TUO employees and students.
External users, including e-INFRA non-employees, will no longer have access.
The license includes GPU support and Linda parallel environment for Gaussian multi-node parallel execution.
## Installed Version
The following versions of Gaussian is available on Karolina, Barbora, and DGX-2 systems.
| Module | CPU support | GPU support | Parallelization | Note | Barbora | DGX-2 | Karolina |
|--------------------------------------|-------------|--------------|-----------------|---------------------|---------|-------| -------- |
| Gaussian/09-a02 | AVX2 | No | SMP + Linda | IT4I compiled | Yes | No | No |
| Gaussian/09-d01 | AVX2 | No | SMP + Linda | IT4I compiled | Yes | No | No |
| Gaussian/16_rev_c0-binary | AVX2 | Yes | SMP | Binary distribution | Yes | Yes | No |
| Gaussian/16_rev_c0-binary-Linda | AVX2 | Yes | SMP + Linda | Binary distribution | Yes | No | No |
| Gaussian/16_rev_c0-CascadeLake | AVX-512 | No | SMP | IT4I compiled | Yes | No | No |
| Gaussian/16_rev_c0-CascadeLake-Linda | AVX-512 | No | SMP + Linda | IT4I compiled | Yes | No | No |
| Gaussian/16_rev_c0-GPU-Linda | AVX2 | Yes | SMP + Linda | IT4I compiled | Yes | No | No |
| Gaussian/16_rev_c0-GPU | AVX2 | Yes | SMP | IT4I compiled | No | Yes | No |
| Gaussian/16_rev_c0-Linda | AVX2 | No | SMP + Linda | IT4I compiled | No | No | No |
| Gaussian/16_rev_c0 | AVX2 | No | SMP + Linda | IT4I compiled | No | No | No |
| Gaussian/16_rev_c2 | AVX2 | Yes | SMP + Linda | IT4I compiled | No | No | Yes |
Speedup may be observed on Barbora and DGX-2 systems when using the `CascadeLake` and `GPU` modules compared to the `binary` module.
## Running
Gaussian is compiled for single node parallel execution as well as multi-node parallel execution using Linda.
GPU support for V100 cards is available on Barbora and DGX-2.
!!! note
By default, the execution is single-core, single-node, and without GPU acceleration.
### Shared-Memory Multiprocessor Parallel Execution (Single Node)
Load module
```bash
$ ml Gaussian/16_rev_c0-binary
```
In the input file Link0 header section, set the CPU cores (e.g. 36 for Barbora, 48 for DGX-2) and memory amount.
```bash
%CPU=0-35
%Mem=8GB
```
### Cluster/Network Parallel Execution (Multi Node)
Load Linda-enabled module
```bash
$ ml Gaussian/16_rev_c0-binary-Linda
```
The network parallelization environment is **Linda**.
In the input file Link0 header section, set the CPU cores (e.g. 36 for Barbora, 48 for DGX-2) and memory amount.
Include the `%UseSSH` keyword, as well. This enables Linda to spawn parallel workers.
```bash
%CPU=0-35
%Mem=8GB
%UseSSH
```
The number and placement of Linda workers may be controlled by %LindaWorkers keyword or by
GAUSS_WDEF environment variable. When running multi-node job via the batch queue, loading
the Linda-enabled module **automatically sets the `GAUSS_WDEF` variable** to the correct node-list, using one worker per node.
In combination with the %CPU keyword, this enables a full-scale multi-node execution.
```bash
$ echo $GAUSS_WDEF
```
If a different amount of Linda workers is required, unset or modify
the GAUSS_WDEF environment variable accordingly.
### GPU-Accelerated Execution (Single Node/Multi Node)
#### Karolina
Karolina is equipped with NVIDIA A100 GPUs and the Ampere architecture requires new CUDA and compiler versions which are supported by the module `Gaussian/16_rev_c2`.
#### Barbora
On Barbora, the GPU acceleration may be combined with the Linda parallelization.
Load Linda-enabled binary module:
```bash
$ ml Gaussian/16_rev_c0-binary-Linda
```
or GPU-enabled module:
```bash
$ ml Gaussian/16_rev_c0-GPU-Linda
```
In the input file Link0 header section, set the CPU cores (24 for Barbora GPU nodes) and memory.
To enable GPU acceleration, set the `%GPUCPU` keyword. This keyword activates GPU accelerators and dedicates CPU cores to drive the GPU accelerators.
On Barbora GPU nodes, we activate GPUs 0-3 and assign cores 0, 2, 12, 14 (two from each CPU socket) to drive the accelerators.
If multi-node computation is intended, include the `%UseSSH` keyword, as well. This enables Linda to spawn parallel workers.
```bash
%CPU=0-23
%GPUCPU=0-3=0,2,12,14
%Mem=8GB
%UseSSH
```
#### DGX-2
GPU-accelerated calculations on the **DGX-2** are supported with Gaussian binary module:
```bash
$ ml Gaussian/16_rev_c0-binary
```
Or IT4I-compiled module
```bash
$ ml Gaussian/16_rev_c0-GPU
```
In the input file Link0 header section, modify the `%CPU` keyword to 48 cores and the `%GPUCPU` keyword to 16 GPU accelerators. Omit the Linda.
```bash
%CPU=0-47
%GPUCPU=0-15=0,2,4,6,8,10,12,14,24,26,28,30,32,34,36,38
%Mem=512GB
```
### Example Input File
This example input file sets water molecule geometry optimization and vibrational frequencies computation
using 36 cores (on Barbora supercomputer) and Linda parallelization.
```bash
%CPU=0-35
%Mem=8GB
%UseSSH
#p rb3lyp/6-31G* test opt freq
Gaussian Test Job:
WATER H20 optimization
0 1
O
H 1 R
H 1 R 2 A
R 0.96
A 109.471221
```
### Run Gaussian (All Modes)
Set a scratch directory:
```bash
$ GAUSS_SCRDIR=/scratch/project/open-0-0/GaussianJob # on Barbora
```
Copy files from a local home to the scratch directory:
```bash
cp * $GAUSS_SCRDIR/
```
Run Gaussian:
```bash
cd $GAUSS_SCRDIR
g16 < input.inp > output.out
```
After the calculation, you can move the data back to your home directory and delete the scratch folder.
For more details, see the [Gaussian documentation][c].
### Example Jobscript
This jobscript will run parallel Gaussian job on Barbora supercomputer, using 4 nodes (4*36 = 144 cores) via Linda. The Linda workers are set
up automatically by the module load.
```bash
#!/bin/bash
#SBATCH --account=PROJECT_ID
#SBATCH --partition=qcpu
#SBATCH --job-name=MY_JOB
#SBATCH --nodes=4
# change to workdir
cd $$SLURM_SUBMIT_DIR
# load Gaussian Linda enabled module and set up Linda
ml Gaussian/16_rev_c0-binary-Linda
# create scratch folder and copy input files
GAUSS_SCRDIR=/scratch/work/project/open-0-0/GaussianJob
mkdir -p $GAUSS_SCRDIR
cd $GAUSS_SCRDIR || exit
cp $SLURM_SUBMIT_DIR/* .
# run Gaussian calculation
# g16 < input.inp > output.out
# run Gaussian from stdin
g16 << EOF > output.out
%CPU=0-35
%Mem=8GB
%UseSSH
#p rb3lyp/6-31G* test opt freq
Gaussian Test Job:
WATER H20 optimization
0 1
O
H 1 R
H 1 R 2 A
R 0.96
A 109.471221
EOF
# copy output files to home
cp * $SLURM_SUBMIT_DIR/. && cd ../
# delete scratch directory
rm -rf $GAUSS_SCRDIR
#end
exit
```
[a]: https://gaussian.com/gaussian16/
[b]: mailto:support@it4i.cz
[c]: https://gaussian.com/man/
# Molpro
## Introduction
MOLPRO is a complete software package used for accurate ab-initio quantum chemistry calculations.
For more information, see the [official webpage][a].
## License
MOLPRO software package is available only to users that have a valid license. Contact support to enable access to MOLPRO if you have a valid license appropriate for running on our cluster (e.g. academic research group licence, parallel execution).
To run MOLPRO, you need to have a valid license token present in `HOME/.molpro/token`. You can download the token from [MOLPRO website][b].
## Installed Versions
For the current list of installed versions, use:
```console
$ ml av Molpro
```
Compilation parameters are default:
| Parameter | Value |
| ---------------------------------- | ------------ |
| max number of atoms | 200 |
| max number of valence orbitals | 300 |
| max number of basis functions | 4095 |
| max number of states per symmetry | 20 |
| max number of state symmetries | 16 |
| max number of records | 200 |
| max number of primitives | maxbfn x [2] |
## Running
MOLPRO is compiled for parallel execution using MPI and OpenMP.
By default, MOLPRO reads the number of allocated nodes from Slurm
and launches a data server on one node.
On the remaining allocated nodes, compute processes are launched, one process per node.
You can modify this behavior by using the `-n`, `-t`, and `helper-server` options.
For more details, see the [MOLPRO documentation][c].
!!! note
The OpenMP parallelization in MOLPRO is limited and has been observed to produce limited scaling. We therefore recommend to use MPI parallelization only. This can be achieved by passing the `--ntasks-per-node=128` and `--cpus-per-task=1` options to Slurm.
You are advised to use the `-d` option to point to a directory in SCRATCH file system.
MOLPRO can produce a large amount of temporary data during its run,
so it is important that these are placed in the fast scratch file system.
### Example jobscript
```bash
#!/bin/bash
#SBATCH --account=PROJECT_ID
#SBATCH --partition=qcpu
#SBATCH --nodes=1
#SBATCH --ntasks-per-node=128
#SBATCH --cpus-per-task=1
cd $SLURM_SUBMIT_DIR
# load Molpro module
ml Molpro/mpp-2024.1.0.linux_x86_64_mpipr
# create a directory in the SCRATCH filesystem
mkdir -p /scratch/project/PROJECT_ID/$SLURM_JOB_ID
cd /scratch/project/PROJECT_ID/$SLURM_JOB_ID
# copy an example input
cp $EBROOTMOLPRO/examples/caffeine_opt_diis.com .
# run Molpro with default options
molpro -d /scratch/project/PROJECT_ID/$SLURM_JOB_ID caffeine_opt_diis.com
exit 0
```
[a]: http://www.molpro.net/
[b]: https://www.molpro.net/licensee/?portal=licensee
[c]: http://www.molpro.net/info/2010.1/doc/manual/node9.html
# NWChem
## Introduction
[NWChem][a] aims to provide its users with computational chemistry tools
that are scalable both in their ability to treat large scientific computational chemistry problems efficiently,
and in their use of available parallel computing resources
from high-performance parallel supercomputers to conventional workstation clusters.
## Installed Versions
For the current list of installed versions, use:
```console
$ ml av NWChem
```
## Running
NWChem is compiled for parallel MPI execution.
A standard procedure for MPI jobs applies.
A sample jobscript (for Karolina on 128 threads) using a sample input file [h2o.nw][1]:
```bash
#SBATCH --account=ACCOUNT_ID
#SBATCH --partition=qcpu
#SBATCH --nodes=1
#SBATCH --ntasks-per-node=128
#SBATCH --cpus-per-task=1
cd $SLURM_SUBMIT_DIR
ml NWChem/7.0.2-intel-2020a-Python-3.8.2-karolina
mpirun nwchem h2o.nw
```
## Options
Refer to [the documentation][b] and set the following directives in the input file:
* MEMORY : controls the amount of memory NWChem will use
* SCRATCH_DIR : set this to a directory in SCRATCH filesystem (or run the calculation completely in a scratch directory). For certain calculations, it might be advisable to reduce I/O by forcing the `direct` mode, e.g. `scf direct`
[1]: ./files-nwchem/h2o.nw
[a]: https://www.nwchem-sw.org/index.php/Main_Page
[b]: https://github.com/nwchemgit/nwchem/wiki